Actual source code: dmpleximpl.h
1: #pragma once
3: #include <petscmat.h>
4: #include <petscdmplex.h>
5: #include <petscdmplextransform.h>
6: #include <petscbt.h>
7: #include <petscsf.h>
8: #include <petsc/private/dmimpl.h>
10: #if defined(PETSC_HAVE_EXODUSII)
11: #include <exodusII.h>
12: #endif
14: PETSC_INTERN PetscBool Plexcite;
15: PETSC_INTERN const char PlexCitation[];
17: PETSC_EXTERN PetscLogEvent DMPLEX_Interpolate;
18: PETSC_EXTERN PetscLogEvent DMPLEX_Partition;
19: PETSC_EXTERN PetscLogEvent DMPLEX_PartSelf;
20: PETSC_EXTERN PetscLogEvent DMPLEX_PartLabelInvert;
21: PETSC_EXTERN PetscLogEvent DMPLEX_PartLabelCreateSF;
22: PETSC_EXTERN PetscLogEvent DMPLEX_PartStratSF;
23: PETSC_EXTERN PetscLogEvent DMPLEX_CreatePointSF;
24: PETSC_EXTERN PetscLogEvent DMPLEX_Distribute;
25: PETSC_EXTERN PetscLogEvent DMPLEX_DistributeMultistage;
26: PETSC_EXTERN PetscLogEvent DMPLEX_DistributeCones;
27: PETSC_EXTERN PetscLogEvent DMPLEX_DistributeLabels;
28: PETSC_EXTERN PetscLogEvent DMPLEX_DistributeSF;
29: PETSC_EXTERN PetscLogEvent DMPLEX_DistributeOverlap;
30: PETSC_EXTERN PetscLogEvent DMPLEX_DistributeField;
31: PETSC_EXTERN PetscLogEvent DMPLEX_DistributeData;
32: PETSC_EXTERN PetscLogEvent DMPLEX_Migrate;
33: PETSC_EXTERN PetscLogEvent DMPLEX_InterpolateSF;
34: PETSC_EXTERN PetscLogEvent DMPLEX_GlobalToNaturalBegin;
35: PETSC_EXTERN PetscLogEvent DMPLEX_GlobalToNaturalEnd;
36: PETSC_EXTERN PetscLogEvent DMPLEX_NaturalToGlobalBegin;
37: PETSC_EXTERN PetscLogEvent DMPLEX_NaturalToGlobalEnd;
38: PETSC_EXTERN PetscLogEvent DMPLEX_Stratify;
39: PETSC_EXTERN PetscLogEvent DMPLEX_Symmetrize;
40: PETSC_EXTERN PetscLogEvent DMPLEX_Preallocate;
41: PETSC_EXTERN PetscLogEvent DMPLEX_ResidualFEM;
42: PETSC_EXTERN PetscLogEvent DMPLEX_JacobianFEM;
43: PETSC_EXTERN PetscLogEvent DMPLEX_InterpolatorFEM;
44: PETSC_EXTERN PetscLogEvent DMPLEX_InjectorFEM;
45: PETSC_EXTERN PetscLogEvent DMPLEX_IntegralFEM;
46: PETSC_EXTERN PetscLogEvent DMPLEX_CreateGmsh;
47: PETSC_EXTERN PetscLogEvent DMPLEX_CreateBoxSFC;
48: PETSC_EXTERN PetscLogEvent DMPLEX_RebalanceSharedPoints;
49: PETSC_EXTERN PetscLogEvent DMPLEX_CreateFromFile;
50: PETSC_EXTERN PetscLogEvent DMPLEX_CreateFromOptions;
51: PETSC_EXTERN PetscLogEvent DMPLEX_BuildFromCellList;
52: PETSC_EXTERN PetscLogEvent DMPLEX_BuildCoordinatesFromCellList;
53: PETSC_EXTERN PetscLogEvent DMPLEX_LocatePoints;
54: PETSC_EXTERN PetscLogEvent DMPLEX_TopologyView;
55: PETSC_EXTERN PetscLogEvent DMPLEX_DistributionView;
56: PETSC_EXTERN PetscLogEvent DMPLEX_LabelsView;
57: PETSC_EXTERN PetscLogEvent DMPLEX_CoordinatesView;
58: PETSC_EXTERN PetscLogEvent DMPLEX_SectionView;
59: PETSC_EXTERN PetscLogEvent DMPLEX_GlobalVectorView;
60: PETSC_EXTERN PetscLogEvent DMPLEX_LocalVectorView;
61: PETSC_EXTERN PetscLogEvent DMPLEX_TopologyLoad;
62: PETSC_EXTERN PetscLogEvent DMPLEX_DistributionLoad;
63: PETSC_EXTERN PetscLogEvent DMPLEX_LabelsLoad;
64: PETSC_EXTERN PetscLogEvent DMPLEX_CoordinatesLoad;
65: PETSC_EXTERN PetscLogEvent DMPLEX_SectionLoad;
66: PETSC_EXTERN PetscLogEvent DMPLEX_GlobalVectorLoad;
67: PETSC_EXTERN PetscLogEvent DMPLEX_LocalVectorLoad;
68: PETSC_EXTERN PetscLogEvent DMPLEX_MetricEnforceSPD;
69: PETSC_EXTERN PetscLogEvent DMPLEX_MetricNormalize;
70: PETSC_EXTERN PetscLogEvent DMPLEX_MetricAverage;
71: PETSC_EXTERN PetscLogEvent DMPLEX_MetricIntersection;
72: PETSC_EXTERN PetscLogEvent DMPLEX_Generate;
73: PETSC_EXTERN PetscLogEvent DMPLEX_GetLocalOffsets;
75: PETSC_EXTERN PetscLogEvent DMPLEX_RebalBuildGraph;
76: PETSC_EXTERN PetscLogEvent DMPLEX_RebalRewriteSF;
77: PETSC_EXTERN PetscLogEvent DMPLEX_RebalGatherGraph;
78: PETSC_EXTERN PetscLogEvent DMPLEX_RebalPartition;
79: PETSC_EXTERN PetscLogEvent DMPLEX_RebalScatterPart;
80: PETSC_EXTERN PetscLogEvent DMPLEX_Uninterpolate;
82: struct _n_PetscGridHash {
83: PetscInt dim;
84: PetscReal lower[3]; /* The lower-left corner */
85: PetscReal upper[3]; /* The upper-right corner */
86: PetscReal extent[3]; /* The box size */
87: PetscReal h[3]; /* The subbox size */
88: PetscInt n[3]; /* The number of subboxes */
89: PetscSection cellSection; /* Offsets for cells in each subbox*/
90: IS cells; /* List of cells in each subbox */
91: DMLabel cellsSparse; /* Sparse storage for cell map */
92: };
94: typedef struct {
95: PetscBool isotropic; /* Is the metric isotropic? */
96: PetscBool uniform; /* Is the metric uniform? */
97: PetscBool restrictAnisotropyFirst; /* Should anisotropy or normalization come first? */
98: PetscBool noInsert; /* Should node insertion/deletion be turned off? */
99: PetscBool noSwap; /* Should facet swapping be turned off? */
100: PetscBool noMove; /* Should node movement be turned off? */
101: PetscBool noSurf; /* Should surface modification be turned off? */
102: PetscReal h_min, h_max; /* Minimum/maximum tolerated metric magnitudes */
103: PetscReal a_max; /* Maximum tolerated anisotropy */
104: PetscReal targetComplexity; /* Target metric complexity */
105: PetscReal p; /* Degree for L-p normalization methods */
106: PetscReal gradationFactor; /* Maximum tolerated length ratio for adjacent edges */
107: PetscReal hausdorffNumber; /* Max. distance between piecewise linear representation of boundary and reconstructed ideal boundary */
108: PetscInt numIter; /* Number of ParMmg mesh adaptation iterations */
109: PetscInt verbosity; /* Level of verbosity for remesher (-1 = no output, 10 = maximum) */
110: } DMPlexMetricCtx;
112: /* Point Numbering in Plex:
114: Points are numbered contiguously by stratum. Strate are organized as follows:
116: First Stratum: Cells [height 0]
117: Second Stratum: Vertices [depth 0]
118: Third Stratum: Faces [height 1]
119: Fourth Stratum: Edges [depth 1]
121: We do this so that the numbering of a cell-vertex mesh does not change after interpolation. Within a given stratum,
122: we allow additional segregation of by cell type.
123: */
124: typedef struct {
125: PetscInt refct;
127: PetscSection coneSection; /* Layout of cones (inedges for DAG) */
128: PetscInt *cones; /* Cone for each point */
129: PetscInt *coneOrientations; /* Orientation of each cone point, means cone traversal should start on point 'o', and if negative start on -(o+1) and go in reverse */
130: PetscSection supportSection; /* Layout of cones (inedges for DAG) */
131: PetscInt *supports; /* Cone for each point */
133: struct { // DMPolytopeType is an enum (usually size 4), but this needs frequent access
134: uint8_t value_as_uint8; // in a struct to guard for stronger typing
135: } *cellTypes;
137: /* Transformation */
138: DMPlexTransform tr; /* Type of transform used to define an ephemeral mesh */
139: char *transformType; /* Type of transform for uniform cell refinement */
140: PetscBool refinementUniform; /* Flag for uniform cell refinement */
141: PetscReal refinementLimit; /* Maximum volume for refined cell */
142: PetscErrorCode (*refinementFunc)(const PetscReal[], PetscReal *); /* Function giving the maximum volume for refined cell */
144: /* Interpolation */
145: DMPlexInterpolatedFlag interpolated;
146: DMPlexInterpolatedFlag interpolatedCollective;
147: PetscBool interpolatePreferTensor; // When different orderings exist, prefer the tensor order
149: /* Ordering */
150: DMReorderDefaultFlag reorderDefault; /* Reorder the DM by default */
152: /* Distribution */
153: PetscBool distDefault; /* Distribute the DM by default */
154: PetscInt overlap; /* Overlap of the partitions as passed to DMPlexDistribute() or DMPlexDistributeOverlap() */
155: PetscInt numOvLabels; /* The number of labels used for candidate overlap points */
156: DMLabel ovLabels[16]; /* Labels used for candidate overlap points */
157: PetscInt ovValues[16]; /* Label values used for candidate overlap points */
158: PetscInt numOvExLabels; /* The number of labels used for exclusion */
159: DMLabel ovExLabels[16]; /* Labels used to exclude points from the overlap */
160: PetscInt ovExValues[16]; /* Label values used to exclude points from the overlap */
161: char *distributionName; /* Name of the specific parallel distribution of the DM */
162: MPI_Comm nonempty_comm; /* Communicator used for visualization when some processes do not have cells */
164: /* Hierarchy */
165: PetscBool regularRefinement; /* This flag signals that we are a regular refinement of coarseMesh */
167: /* Generation */
168: char *tetgenOpts;
169: char *triangleOpts;
170: PetscPartitioner partitioner;
171: PetscBool partitionBalance; /* Evenly divide partition overlap when distributing */
172: PetscBool remeshBd;
174: /* Submesh */
175: DMLabel subpointMap; /* Label each original mesh point in the submesh with its depth, subpoint are the implicit numbering */
176: IS subpointIS; /* IS holding point number in the enclosing mesh of every point in the submesh chart */
177: PetscObjectState subpointState; /* The state of subpointMap when the subpointIS was last created */
179: /* Labels and numbering */
180: PetscObjectState depthState; /* State of depth label, so that we can determine if a user changes it */
181: PetscObjectState celltypeState; /* State of celltype label, so that we can determine if a user changes it */
182: IS globalVertexNumbers;
183: IS globalCellNumbers;
185: /* Constraints */
186: PetscSection anchorSection; /* maps constrained points to anchor points */
187: IS anchorIS; /* anchors indexed by the above section */
188: PetscErrorCode (*createanchors)(DM); /* automatically compute anchors (probably from tree constraints) */
189: PetscErrorCode (*computeanchormatrix)(DM, PetscSection, PetscSection, Mat);
191: /* Tree: automatically construct constraints for hierarchically non-conforming meshes */
192: PetscSection parentSection; /* dof == 1 if point has parent */
193: PetscInt *parents; /* point to parent */
194: PetscInt *childIDs; /* point to child ID */
195: PetscSection childSection; /* inverse of parent section */
196: PetscInt *children; /* point to children */
197: DM referenceTree; /* reference tree to which child ID's refer */
198: PetscErrorCode (*getchildsymmetry)(DM, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt *, PetscInt *);
200: /* MATIS support */
201: PetscSection subdomainSection;
203: /* Adjacency */
204: PetscBool useAnchors; /* Replace constrained points with their anchors in adjacency lists */
205: PetscErrorCode (*useradjacency)(DM, PetscInt, PetscInt *, PetscInt[], void *); /* User callback for adjacency */
206: void *useradjacencyctx; /* User context for callback */
208: // Periodicity
209: struct {
210: // Specified by the user
211: PetscInt num_face_sfs; // number of face_sfs
212: PetscSF *face_sfs; // root(donor faces) <-- leaf(local faces)
213: PetscScalar (*transform)[4][4]; // geometric transform
214: // Created eagerly (depends on points)
215: PetscSF composed_sf; // root(non-periodic global points) <-- leaf(local points)
216: IS *periodic_points;
217: } periodic;
219: /* Projection */
220: PetscInt maxProjectionHeight; /* maximum height of cells used in DMPlexProject functions */
221: PetscInt activePoint; /* current active point in iteration */
223: /* Output */
224: PetscInt vtkCellHeight; /* The height of cells for output, default is 0 */
225: PetscReal scale[NUM_PETSC_UNITS]; /* The scale for each SI unit */
227: /* Geometry */
228: PetscReal minradius; /* Minimum distance from cell centroid to face */
229: PetscBool useHashLocation; /* Use grid hashing for point location */
230: PetscGridHash lbox; /* Local box for searching */
231: PetscPointFn *coordFunc; /* Function used to remap newly introduced vertices */
233: /* Neighbors */
234: PetscMPIInt *neighbors;
236: /* Metric */
237: DMPlexMetricCtx *metricCtx;
239: /* FEM */
240: PetscBool useCeed; /* This should convert to a registration system when there are more FEM backends */
241: PetscBool useMatClPerm; /* Use the closure permutation when assembling matrices */
243: /* CAD */
244: PetscBool ignoreModel; /* If TRUE, Plex refinement will skip Snap-To-Geometry feature ignoring attached CAD geometry information */
246: // Transforms
247: PetscBool saveTransform; // Flag to save transform, if this mesh was produced by a transform
248: DMPlexTransform transform; // Transform producing this mesh (note that this will hold on to the original mesh too)
250: /* Debugging */
251: PetscBool printSetValues;
252: PetscInt printAdj;
253: PetscInt printFEM;
254: PetscInt printFVM;
255: PetscInt printL2;
256: PetscInt printLocate;
257: PetscInt printProject;
258: PetscReal printTol;
259: } DM_Plex;
261: PETSC_INTERN PetscErrorCode DMPlexCopy_Internal(DM, PetscBool, PetscBool, DM);
262: PETSC_INTERN PetscErrorCode DMPlexReplace_Internal(DM, DM *);
263: PETSC_INTERN PetscErrorCode DMPlexCopyEGADSInfo_Internal(DM, DM);
265: PETSC_INTERN PetscErrorCode DMPlexVTKWriteAll_VTU(DM, PetscViewer);
266: PETSC_INTERN PetscErrorCode VecView_Plex_Local(Vec, PetscViewer);
267: PETSC_INTERN PetscErrorCode VecView_Plex_Native(Vec, PetscViewer);
268: PETSC_INTERN PetscErrorCode VecView_Plex(Vec, PetscViewer);
269: PETSC_INTERN PetscErrorCode VecLoad_Plex_Local(Vec, PetscViewer);
270: PETSC_INTERN PetscErrorCode VecLoad_Plex_Native(Vec, PetscViewer);
271: PETSC_INTERN PetscErrorCode VecLoad_Plex(Vec, PetscViewer);
272: PETSC_INTERN PetscErrorCode DMPlexGetFieldType_Internal(DM, PetscSection, PetscInt, PetscInt *, PetscInt *, PetscViewerVTKFieldType *);
273: PETSC_INTERN PetscErrorCode DMPlexGetFieldTypes_Internal(DM, PetscSection, PetscInt, PetscInt *, PetscInt **, PetscInt **, PetscViewerVTKFieldType **);
274: PETSC_INTERN PetscErrorCode DMPlexRestoreFieldTypes_Internal(DM, PetscSection, PetscInt, PetscInt *, PetscInt **, PetscInt **, PetscViewerVTKFieldType **);
275: PETSC_INTERN PetscErrorCode DMPlexView_GLVis(DM, PetscViewer);
276: PETSC_INTERN PetscErrorCode DMSetUpGLVisViewer_Plex(PetscObject, PetscViewer);
277: #if defined(PETSC_HAVE_HDF5)
278: PETSC_EXTERN PetscErrorCode VecView_Plex_Local_HDF5(Vec, PetscViewer);
279: PETSC_EXTERN PetscErrorCode VecView_Plex_HDF5(Vec, PetscViewer);
280: PETSC_EXTERN PetscErrorCode VecLoad_Plex_HDF5(Vec, PetscViewer);
281: PETSC_EXTERN PetscErrorCode VecView_Plex_HDF5_Native(Vec, PetscViewer);
282: PETSC_EXTERN PetscErrorCode VecLoad_Plex_HDF5_Native(Vec, PetscViewer);
283: PETSC_EXTERN PetscErrorCode DMPlexView_HDF5(DM, PetscViewer);
284: PETSC_EXTERN PetscErrorCode DMPlexLoad_HDF5(DM, PetscViewer);
285: PETSC_INTERN PetscErrorCode DMPlexTopologyView_HDF5_Internal(DM, IS, PetscViewer);
286: PETSC_INTERN PetscErrorCode DMPlexCoordinatesView_HDF5_Internal(DM, PetscViewer);
287: PETSC_INTERN PetscErrorCode DMPlexLabelsView_HDF5_Internal(DM, IS, PetscViewer);
288: PETSC_INTERN PetscErrorCode DMPlexSectionView_HDF5_Internal(DM, PetscViewer, DM);
289: PETSC_INTERN PetscErrorCode DMPlexGlobalVectorView_HDF5_Internal(DM, PetscViewer, DM, Vec);
290: PETSC_INTERN PetscErrorCode DMPlexLocalVectorView_HDF5_Internal(DM, PetscViewer, DM, Vec);
291: PETSC_INTERN PetscErrorCode DMPlexTopologyLoad_HDF5_Internal(DM, PetscViewer, PetscSF *);
292: PETSC_INTERN PetscErrorCode DMPlexCoordinatesLoad_HDF5_Internal(DM, PetscViewer, PetscSF);
293: PETSC_INTERN PetscErrorCode DMPlexLabelsLoad_HDF5_Internal(DM, PetscViewer, PetscSF);
294: PETSC_INTERN PetscErrorCode DMPlexSectionLoad_HDF5_Internal(DM, PetscViewer, DM, PetscSF, PetscSF *, PetscSF *);
295: PETSC_INTERN PetscErrorCode DMPlexVecLoad_HDF5_Internal(DM, PetscViewer, DM, PetscSF, Vec);
296: PETSC_INTERN PetscErrorCode DMPlexView_HDF5_Internal(DM, PetscViewer);
297: PETSC_INTERN PetscErrorCode DMPlexLoad_HDF5_Internal(DM, PetscViewer);
298: PETSC_INTERN PetscErrorCode DMPlexLoad_HDF5_Xdmf_Internal(DM, PetscViewer);
299: PETSC_INTERN PetscErrorCode VecView_Plex_HDF5_Internal(Vec, PetscViewer);
300: PETSC_INTERN PetscErrorCode VecView_Plex_HDF5_Native_Internal(Vec, PetscViewer);
301: PETSC_INTERN PetscErrorCode VecView_Plex_Local_HDF5_Internal(Vec, PetscViewer);
302: PETSC_INTERN PetscErrorCode VecLoad_Plex_HDF5_Internal(Vec, PetscViewer);
303: PETSC_INTERN PetscErrorCode VecLoad_Plex_HDF5_Native_Internal(Vec, PetscViewer);
304: #endif
305: PETSC_EXTERN PetscErrorCode VecView_Plex_Local_CGNS(Vec, PetscViewer);
306: #if defined(PETSC_HAVE_CGNS)
307: PETSC_EXTERN PetscErrorCode VecLoad_Plex_CGNS_Internal(Vec, PetscViewer);
308: #endif
310: PETSC_INTERN PetscErrorCode DMPlexVecGetClosure_Internal(DM, PetscSection, PetscBool, Vec, PetscInt, PetscInt *, PetscScalar *[]);
311: PETSC_INTERN PetscErrorCode DMPlexVecGetClosureAtDepth_Internal(DM, PetscSection, Vec, PetscInt, PetscInt, PetscInt *, PetscScalar *[]);
312: PETSC_INTERN PetscErrorCode DMPlexClosurePoints_Private(DM, PetscInt, const PetscInt[], IS *);
313: PETSC_INTERN PetscErrorCode DMSetFromOptions_NonRefinement_Plex(DM, PetscOptionItems);
314: PETSC_INTERN PetscErrorCode DMSetFromOptions_Overlap_Plex(DM, PetscOptionItems, PetscInt *);
315: PETSC_INTERN PetscErrorCode DMCoarsen_Plex(DM, MPI_Comm, DM *);
316: PETSC_INTERN PetscErrorCode DMCoarsenHierarchy_Plex(DM, PetscInt, DM[]);
317: PETSC_INTERN PetscErrorCode DMRefine_Plex(DM, MPI_Comm, DM *);
318: PETSC_INTERN PetscErrorCode DMRefineHierarchy_Plex(DM, PetscInt, DM[]);
319: PETSC_INTERN PetscErrorCode DMAdaptLabel_Plex(DM, Vec, DMLabel, DMLabel, DM *);
320: PETSC_INTERN PetscErrorCode DMExtrude_Plex(DM, PetscInt, DM *);
321: PETSC_INTERN PetscErrorCode DMPlexInsertBoundaryValues_Plex(DM, PetscBool, Vec, PetscReal, Vec, Vec, Vec);
322: PETSC_INTERN PetscErrorCode DMPlexInsertTimeDerivativeBoundaryValues_Plex(DM, PetscBool, Vec, PetscReal, Vec, Vec, Vec);
323: PETSC_INTERN PetscErrorCode DMPlexInsertBounds_Plex(DM, PetscBool, PetscReal, Vec);
324: PETSC_INTERN PetscErrorCode DMProjectFunctionLocal_Plex(DM, PetscReal, PetscErrorCode (**)(PetscInt, PetscReal, const PetscReal[], PetscInt, PetscScalar *, void *), void **, InsertMode, Vec);
325: PETSC_INTERN PetscErrorCode DMProjectFunctionLabelLocal_Plex(DM, PetscReal, DMLabel, PetscInt, const PetscInt[], PetscInt, const PetscInt[], PetscErrorCode (**)(PetscInt, PetscReal, const PetscReal[], PetscInt, PetscScalar *, void *), void **, InsertMode, Vec);
326: PETSC_INTERN PetscErrorCode DMProjectFieldLocal_Plex(DM, PetscReal, Vec, void (**)(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]), InsertMode, Vec);
327: PETSC_INTERN PetscErrorCode DMProjectFieldLabelLocal_Plex(DM, PetscReal, DMLabel, PetscInt, const PetscInt[], PetscInt, const PetscInt[], Vec, void (**)(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]), InsertMode, Vec);
328: PETSC_INTERN PetscErrorCode DMProjectBdFieldLabelLocal_Plex(DM, PetscReal, DMLabel, PetscInt, const PetscInt[], PetscInt, const PetscInt[], Vec, void (**)(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]), InsertMode, Vec);
329: PETSC_INTERN PetscErrorCode DMComputeL2Diff_Plex(DM, PetscReal, PetscErrorCode (**)(PetscInt, PetscReal, const PetscReal[], PetscInt, PetscScalar *, void *), void **, Vec, PetscReal *);
330: PETSC_INTERN PetscErrorCode DMComputeL2GradientDiff_Plex(DM, PetscReal, PetscErrorCode (**)(PetscInt, PetscReal, const PetscReal[], const PetscReal[], PetscInt, PetscScalar *, void *), void **, Vec, const PetscReal[], PetscReal *);
331: PETSC_INTERN PetscErrorCode DMComputeL2FieldDiff_Plex(DM, PetscReal, PetscErrorCode (**)(PetscInt, PetscReal, const PetscReal[], PetscInt, PetscScalar *, void *), void **, Vec, PetscReal *);
332: PETSC_INTERN PetscErrorCode DMLocatePoints_Plex(DM, Vec, DMPointLocationType, PetscSF);
334: #if defined(PETSC_HAVE_EXODUSII)
335: PETSC_INTERN PetscErrorCode DMView_PlexExodusII(DM, PetscViewer);
336: PETSC_INTERN PetscErrorCode VecView_PlexExodusII_Internal(Vec, PetscViewer);
337: PETSC_INTERN PetscErrorCode VecLoad_PlexExodusII_Internal(Vec, PetscViewer);
338: #endif
339: PETSC_INTERN PetscErrorCode DMView_PlexCGNS(DM, PetscViewer);
340: PETSC_INTERN PetscErrorCode DMPlexCreateCGNSFromFile_Internal(MPI_Comm, const char *, PetscBool, DM *);
341: PETSC_INTERN PetscErrorCode DMPlexCreateCGNS_Internal_Serial(MPI_Comm, PetscInt, PetscBool, DM *);
342: PETSC_INTERN PetscErrorCode DMPlexCreateCGNS_Internal_Parallel(MPI_Comm, PetscInt, PetscBool, DM *);
343: PETSC_INTERN PetscErrorCode DMPlexVTKGetCellType_Internal(DM, PetscInt, PetscInt, PetscInt *);
344: PETSC_INTERN PetscErrorCode DMPlexGetAdjacency_Internal(DM, PetscInt, PetscBool, PetscBool, PetscBool, PetscInt *, PetscInt *[]);
345: PETSC_INTERN PetscErrorCode DMPlexGetMaxAdjacencySize_Internal(DM, PetscBool, PetscInt *);
346: PETSC_INTERN PetscErrorCode DMPlexGetRawFaces_Internal(DM, DMPolytopeType, const PetscInt[], PetscInt *, const DMPolytopeType *[], const PetscInt *[], const PetscInt *[]);
347: PETSC_INTERN PetscErrorCode DMPlexRestoreRawFaces_Internal(DM, DMPolytopeType, const PetscInt[], PetscInt *, const DMPolytopeType *[], const PetscInt *[], const PetscInt *[]);
348: PETSC_INTERN PetscErrorCode DMPlexComputeCellType_Internal(DM, PetscInt, PetscInt, DMPolytopeType *);
349: PETSC_INTERN PetscErrorCode DMPlexVecSetFieldClosure_Internal(DM, PetscSection, Vec, PetscBool[], PetscInt, PetscInt, const PetscInt[], DMLabel, PetscInt, const PetscScalar[], InsertMode);
350: PETSC_INTERN PetscErrorCode DMPlexProjectConstraints_Internal(DM, Vec, Vec);
351: PETSC_EXTERN PetscErrorCode DMPlexCreateReferenceTree_SetTree(DM, PetscSection, PetscInt[], PetscInt[]);
352: PETSC_EXTERN PetscErrorCode DMPlexCreateReferenceTree_Union(DM, DM, const char *, DM *);
353: PETSC_EXTERN PetscErrorCode DMPlexComputeInterpolatorTree(DM, DM, PetscSF, PetscInt *, Mat);
354: PETSC_EXTERN PetscErrorCode DMPlexComputeInjectorTree(DM, DM, PetscSF, PetscInt *, Mat);
355: PETSC_INTERN PetscErrorCode DMPlexAnchorsModifyMat(DM, PetscSection, PetscInt, PetscInt, const PetscInt[], const PetscInt ***, const PetscScalar[], PetscInt *, PetscInt *, PetscInt *[], PetscScalar *[], PetscInt[], PetscBool);
356: PETSC_INTERN PetscErrorCode DMPlexAnchorsModifyMat_Internal(DM, PetscSection, PetscInt, PetscInt, const PetscInt[], const PetscInt ***, PetscInt, PetscInt, const PetscScalar[], PetscInt *, PetscInt *, PetscInt *[], PetscScalar *[], PetscInt[], PetscBool, PetscBool);
357: PETSC_INTERN PetscErrorCode DMPlexAnchorsGetSubMatModification(DM, PetscSection, PetscInt, PetscInt, const PetscInt[], const PetscInt ***, PetscInt *, PetscInt *, PetscInt *[], PetscInt[], PetscScalar *[]);
358: PETSC_INTERN PetscErrorCode DMPlexLocatePoint_Internal(DM, PetscInt, const PetscScalar[], PetscInt, PetscInt *);
359: /* this is PETSC_EXTERN just because of src/dm/impls/plex/tests/ex18.c */
360: PETSC_EXTERN PetscErrorCode DMPlexOrientInterface_Internal(DM);
361: PETSC_INTERN PetscErrorCode DMPlexOrientCells_Internal(DM, IS, IS);
363: /* Applications may use this function */
364: PETSC_EXTERN PetscErrorCode DMPlexCreateNumbering_Plex(DM, PetscInt, PetscInt, PetscInt, PetscInt *, PetscSF, IS *);
366: PETSC_INTERN PetscErrorCode DMPlexInterpolateInPlace_Internal(DM);
367: PETSC_INTERN PetscErrorCode DMPlexCreateBoxMesh_Tensor_SFC_Internal(DM, PetscInt, const PetscInt[], const PetscReal[], const PetscReal[], const DMBoundaryType[], PetscBool);
368: PETSC_INTERN PetscErrorCode DMPlexMigrateIsoperiodicFaceSF_Internal(DM, DM, PetscSF);
369: PETSC_INTERN PetscErrorCode DMPlexCreateVertexNumbering_Internal(DM, PetscBool, IS *);
370: PETSC_INTERN PetscErrorCode DMPlexRefine_Internal(DM, Vec, DMLabel, DMLabel, DM *);
371: PETSC_INTERN PetscErrorCode DMPlexCoarsen_Internal(DM, Vec, DMLabel, DMLabel, DM *);
372: PETSC_INTERN PetscErrorCode DMCreateMatrix_Plex(DM, Mat *);
374: PETSC_INTERN PetscErrorCode DMPlexGetOverlap_Plex(DM, PetscInt *);
375: PETSC_INTERN PetscErrorCode DMPlexSetOverlap_Plex(DM, DM, PetscInt);
376: PETSC_INTERN PetscErrorCode DMPlexDistributeGetDefault_Plex(DM, PetscBool *);
377: PETSC_INTERN PetscErrorCode DMPlexDistributeSetDefault_Plex(DM, PetscBool);
378: PETSC_INTERN PetscErrorCode DMPlexReorderGetDefault_Plex(DM, DMReorderDefaultFlag *);
379: PETSC_INTERN PetscErrorCode DMPlexReorderSetDefault_Plex(DM, DMReorderDefaultFlag);
380: PETSC_INTERN PetscErrorCode DMPlexGetUseCeed_Plex(DM, PetscBool *);
381: PETSC_INTERN PetscErrorCode DMPlexSetUseCeed_Plex(DM, PetscBool);
382: PETSC_INTERN PetscErrorCode DMReorderSectionGetDefault_Plex(DM, DMReorderDefaultFlag *);
383: PETSC_INTERN PetscErrorCode DMReorderSectionSetDefault_Plex(DM, DMReorderDefaultFlag);
384: PETSC_INTERN PetscErrorCode DMReorderSectionGetType_Plex(DM, MatOrderingType *);
385: PETSC_INTERN PetscErrorCode DMReorderSectionSetType_Plex(DM, MatOrderingType);
387: #if 1
388: static inline PetscInt DihedralInvert(PetscInt N, PetscInt a)
389: {
390: return (a <= 0) ? a : (N - a);
391: }
393: static inline PetscInt DihedralCompose(PetscInt N, PetscInt a, PetscInt b)
394: {
395: if (!N) return 0;
396: return (a >= 0) ? ((b >= 0) ? ((a + b) % N) : -(((a - b - 1) % N) + 1)) : ((b >= 0) ? -(((N - b - a - 1) % N) + 1) : ((N + b - a) % N));
397: }
399: static inline PetscInt DihedralSwap(PetscInt N, PetscInt a, PetscInt b)
400: {
401: return DihedralCompose(N, DihedralInvert(N, a), b);
402: }
403: #else
404: /* TODO
405: This is a reimplementation of the tensor dihedral symmetries using the new orientations.
406: These should be turned on when we convert to new-style orientations in p4est.
407: */
408: /* invert dihedral symmetry: return a^-1,
409: * using the representation described in
410: * DMPlexGetConeOrientation() */
411: static inline PetscInt DihedralInvert(PetscInt N, PetscInt a)
412: {
413: switch (N) {
414: case 0:
415: return 0;
416: case 2:
417: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_SEGMENT, 0, a);
418: case 4:
419: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_QUADRILATERAL, 0, a);
420: case 8:
421: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_HEXAHEDRON, 0, a);
422: default:
423: SETERRABORT(PETSC_COMM_SELF, PETSC_ERR_ARG_WRONG, "Invalid celltype for DihedralInvert()");
424: }
425: return 0;
426: }
428: /* compose dihedral symmetry: return b * a,
429: * using the representation described in
430: * DMPlexGetConeOrientation() */
431: static inline PetscInt DihedralCompose(PetscInt N, PetscInt a, PetscInt b)
432: {
433: switch (N) {
434: case 0:
435: return 0;
436: case 2:
437: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_SEGMENT, b, a);
438: case 4:
439: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_QUADRILATERAL, b, a);
440: case 8:
441: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_HEXAHEDRON, b, a);
442: default:
443: SETERRABORT(PETSC_COMM_SELF, PETSC_ERR_ARG_WRONG, "Invalid celltype for DihedralCompose()");
444: }
445: return 0;
446: }
448: /* swap dihedral symmetries: return b * a^-1,
449: * using the representation described in
450: * DMPlexGetConeOrientation() */
451: static inline PetscInt DihedralSwap(PetscInt N, PetscInt a, PetscInt b)
452: {
453: switch (N) {
454: case 0:
455: return 0;
456: case 2:
457: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_SEGMENT, b, a);
458: case 4:
459: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_QUADRILATERAL, b, a);
460: case 8:
461: return DMPolytopeTypeComposeOrientationInv(DM_POLYTOPE_HEXAHEDRON, b, a);
462: default:
463: SETERRABORT(PETSC_COMM_SELF, PETSC_ERR_ARG_WRONG, "Invalid celltype for DihedralCompose()");
464: }
465: return 0;
466: }
467: #endif
468: PETSC_INTERN PetscInt DMPolytopeConvertNewOrientation_Internal(DMPolytopeType, PetscInt);
469: PETSC_INTERN PetscInt DMPolytopeConvertOldOrientation_Internal(DMPolytopeType, PetscInt);
470: PETSC_INTERN PetscErrorCode DMPlexConvertOldOrientations_Internal(DM);
472: PETSC_SINGLE_LIBRARY_VISIBILITY_INTERNAL PetscErrorCode DMPlexComputeIntegral_Internal(DM, Vec, PetscInt, PetscInt, PetscScalar *, void *);
473: PETSC_INTERN PetscErrorCode DMPlexReconstructGradients_Internal(DM, PetscFV, PetscInt, PetscInt, Vec, Vec, Vec, Vec);
475: /* Matvec with A in row-major storage, x and y can be aliased */
476: static inline void DMPlex_Mult2D_Internal(const PetscScalar A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
477: {
478: const PetscScalar z[2] = {x[0 * ldx], x[1 * ldx]};
479: y[0 * ldx] = A[0] * z[0] + A[1] * z[1];
480: y[1 * ldx] = A[2] * z[0] + A[3] * z[1];
481: (void)PetscLogFlops(6.0);
482: }
483: static inline void DMPlex_Mult3D_Internal(const PetscScalar A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
484: {
485: const PetscScalar z[3] = {x[0 * ldx], x[1 * ldx], x[2 * ldx]};
486: y[0 * ldx] = A[0] * z[0] + A[1] * z[1] + A[2] * z[2];
487: y[1 * ldx] = A[3] * z[0] + A[4] * z[1] + A[5] * z[2];
488: y[2 * ldx] = A[6] * z[0] + A[7] * z[1] + A[8] * z[2];
489: (void)PetscLogFlops(15.0);
490: }
491: static inline void DMPlex_MultTranspose2D_Internal(const PetscScalar A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
492: {
493: const PetscScalar z[2] = {x[0 * ldx], x[1 * ldx]};
494: y[0 * ldx] = A[0] * z[0] + A[2] * z[1];
495: y[1 * ldx] = A[1] * z[0] + A[3] * z[1];
496: (void)PetscLogFlops(6.0);
497: }
498: static inline void DMPlex_MultTranspose3D_Internal(const PetscScalar A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
499: {
500: const PetscScalar z[3] = {x[0 * ldx], x[1 * ldx], x[2 * ldx]};
501: y[0 * ldx] = PetscConj(A[0]) * z[0] + PetscConj(A[3]) * z[1] + PetscConj(A[6]) * z[2];
502: y[1 * ldx] = PetscConj(A[1]) * z[0] + PetscConj(A[4]) * z[1] + PetscConj(A[7]) * z[2];
503: y[2 * ldx] = PetscConj(A[2]) * z[0] + PetscConj(A[5]) * z[1] + PetscConj(A[8]) * z[2];
504: (void)PetscLogFlops(15.0);
505: }
506: static inline void DMPlex_Mult2DReal_Internal(const PetscReal A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
507: {
508: const PetscScalar z[2] = {x[0 * ldx], x[1 * ldx]};
509: y[0 * ldx] = A[0] * z[0] + A[1] * z[1];
510: y[1 * ldx] = A[2] * z[0] + A[3] * z[1];
511: (void)PetscLogFlops(6.0);
512: }
513: static inline void DMPlex_Mult3DReal_Internal(const PetscReal A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
514: {
515: const PetscScalar z[3] = {x[0 * ldx], x[1 * ldx], x[2 * ldx]};
516: y[0 * ldx] = A[0] * z[0] + A[1] * z[1] + A[2] * z[2];
517: y[1 * ldx] = A[3] * z[0] + A[4] * z[1] + A[5] * z[2];
518: y[2 * ldx] = A[6] * z[0] + A[7] * z[1] + A[8] * z[2];
519: (void)PetscLogFlops(15.0);
520: }
521: static inline void DMPlex_MultAdd2DReal_Internal(const PetscReal A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
522: {
523: const PetscScalar z[2] = {x[0 * ldx], x[1 * ldx]};
524: y[0 * ldx] += A[0] * z[0] + A[1] * z[1];
525: y[1 * ldx] += A[2] * z[0] + A[3] * z[1];
526: (void)PetscLogFlops(6.0);
527: }
528: static inline void DMPlex_MultAdd3DReal_Internal(const PetscReal A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
529: {
530: const PetscScalar z[3] = {x[0 * ldx], x[1 * ldx], x[2 * ldx]};
531: y[0 * ldx] += A[0] * z[0] + A[1] * z[1] + A[2] * z[2];
532: y[1 * ldx] += A[3] * z[0] + A[4] * z[1] + A[5] * z[2];
533: y[2 * ldx] += A[6] * z[0] + A[7] * z[1] + A[8] * z[2];
534: (void)PetscLogFlops(15.0);
535: }
536: /*
537: A: packed, row-major m x n array
538: x: length m array
539: y: length n arra
540: ldx: the stride in x and y
542: A[i,j] = A[i * n + j]
543: A^T[j,i] = A[i,j]
544: */
545: static inline void DMPlex_MultTransposeReal_Internal(const PetscReal A[], PetscInt m, PetscInt n, PetscInt ldx, const PetscScalar x[], PetscScalar y[])
546: {
547: PetscScalar z[3];
548: PetscInt i, j;
549: for (i = 0; i < m; ++i) z[i] = x[i * ldx];
550: for (j = 0; j < n; ++j) {
551: const PetscInt l = j * ldx;
552: y[l] = 0;
553: for (i = 0; i < m; ++i) y[l] += A[i * n + j] * z[i];
554: }
555: (void)PetscLogFlops(2 * m * n);
556: }
557: static inline void DMPlex_MultTranspose2DReal_Internal(const PetscReal A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
558: {
559: const PetscScalar z[2] = {x[0 * ldx], x[1 * ldx]};
560: y[0 * ldx] = A[0] * z[0] + A[2] * z[1];
561: y[1 * ldx] = A[1] * z[0] + A[3] * z[1];
562: (void)PetscLogFlops(6.0);
563: }
564: static inline void DMPlex_MultTranspose3DReal_Internal(const PetscReal A[], PetscInt ldx, const PetscScalar x[], PetscScalar y[])
565: {
566: const PetscScalar z[3] = {x[0 * ldx], x[1 * ldx], x[2 * ldx]};
567: y[0 * ldx] = A[0] * z[0] + A[3] * z[1] + A[6] * z[2];
568: y[1 * ldx] = A[1] * z[0] + A[4] * z[1] + A[7] * z[2];
569: y[2 * ldx] = A[2] * z[0] + A[5] * z[1] + A[8] * z[2];
570: (void)PetscLogFlops(15.0);
571: }
573: static inline void DMPlex_MatMult2D_Internal(const PetscScalar A[], PetscInt n, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
574: {
575: #define PLEX_DIM__ 2
576: PetscScalar z[PLEX_DIM__];
577: for (PetscInt j = 0; j < n; ++j) {
578: for (int d = 0; d < PLEX_DIM__; ++d) z[d] = B[d * ldb + j];
579: DMPlex_Mult2D_Internal(A, 1, z, z);
580: for (int d = 0; d < PLEX_DIM__; ++d) C[d * ldb + j] = z[d];
581: }
582: (void)PetscLogFlops(8.0 * n);
583: #undef PLEX_DIM__
584: }
585: static inline void DMPlex_MatMult3D_Internal(const PetscScalar A[], PetscInt n, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
586: {
587: #define PLEX_DIM__ 3
588: PetscScalar z[PLEX_DIM__];
589: for (PetscInt j = 0; j < n; ++j) {
590: for (int d = 0; d < PLEX_DIM__; ++d) z[d] = B[d * ldb + j];
591: DMPlex_Mult3D_Internal(A, 1, z, z);
592: for (int d = 0; d < PLEX_DIM__; ++d) C[d * ldb + j] = z[d];
593: }
594: (void)PetscLogFlops(8.0 * n);
595: #undef PLEX_DIM__
596: }
597: static inline void DMPlex_MatMultTranspose2D_Internal(const PetscScalar A[], PetscInt n, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
598: {
599: #define PLEX_DIM__ 2
600: PetscScalar z[PLEX_DIM__];
601: for (PetscInt j = 0; j < n; ++j) {
602: for (int d = 0; d < PLEX_DIM__; ++d) z[d] = B[d * ldb + j];
603: DMPlex_MultTranspose2D_Internal(A, 1, z, z);
604: for (int d = 0; d < PLEX_DIM__; ++d) C[d * ldb + j] = z[d];
605: }
606: (void)PetscLogFlops(8.0 * n);
607: #undef PLEX_DIM__
608: }
609: static inline void DMPlex_MatMultTranspose3D_Internal(const PetscScalar A[], PetscInt n, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
610: {
611: #define PLEX_DIM__ 3
612: PetscScalar z[PLEX_DIM__];
613: for (PetscInt j = 0; j < n; ++j) {
614: for (int d = 0; d < PLEX_DIM__; ++d) z[d] = B[d * ldb + j];
615: DMPlex_MultTranspose3D_Internal(A, 1, z, z);
616: for (int d = 0; d < PLEX_DIM__; ++d) C[d * ldb + j] = z[d];
617: }
618: (void)PetscLogFlops(8.0 * n);
619: #undef PLEX_DIM__
620: }
622: static inline void DMPlex_MatMultLeft2D_Internal(const PetscScalar A[], PetscInt m, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
623: {
624: for (PetscInt j = 0; j < m; ++j) DMPlex_MultTranspose2D_Internal(A, 1, &B[j * ldb], &C[j * ldb]);
625: (void)PetscLogFlops(8.0 * m);
626: }
627: static inline void DMPlex_MatMultLeft3D_Internal(const PetscScalar A[], PetscInt m, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
628: {
629: for (PetscInt j = 0; j < m; ++j) DMPlex_MultTranspose3D_Internal(A, 1, &B[j * ldb], &C[j * ldb]);
630: (void)PetscLogFlops(8.0 * m);
631: }
632: static inline void DMPlex_MatMultTransposeLeft2D_Internal(const PetscScalar A[], PetscInt m, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
633: {
634: for (PetscInt j = 0; j < m; ++j) DMPlex_Mult2D_Internal(A, 1, &B[j * ldb], &C[j * ldb]);
635: (void)PetscLogFlops(8.0 * m);
636: }
637: static inline void DMPlex_MatMultTransposeLeft3D_Internal(const PetscScalar A[], PetscInt m, PetscInt ldb, const PetscScalar B[], PetscScalar C[])
638: {
639: for (PetscInt j = 0; j < m; ++j) DMPlex_Mult3D_Internal(A, 1, &B[j * ldb], &C[j * ldb]);
640: (void)PetscLogFlops(8.0 * m);
641: }
643: static inline void DMPlex_PTAP2DReal_Internal(const PetscReal P[], const PetscScalar A[], PetscScalar C[])
644: {
645: PetscScalar out[4];
646: PetscInt i, j, k, l;
647: for (i = 0; i < 2; ++i) {
648: for (j = 0; j < 2; ++j) {
649: out[i * 2 + j] = 0.;
650: for (k = 0; k < 2; ++k) {
651: for (l = 0; l < 2; ++l) out[i * 2 + j] += P[k * 2 + i] * A[k * 2 + l] * P[l * 2 + j];
652: }
653: }
654: }
655: for (i = 0; i < 2 * 2; ++i) C[i] = out[i];
656: (void)PetscLogFlops(48.0);
657: }
658: static inline void DMPlex_PTAP3DReal_Internal(const PetscReal P[], const PetscScalar A[], PetscScalar C[])
659: {
660: PetscScalar out[9];
661: PetscInt i, j, k, l;
662: for (i = 0; i < 3; ++i) {
663: for (j = 0; j < 3; ++j) {
664: out[i * 3 + j] = 0.;
665: for (k = 0; k < 3; ++k) {
666: for (l = 0; l < 3; ++l) out[i * 3 + j] += P[k * 3 + i] * A[k * 3 + l] * P[l * 3 + j];
667: }
668: }
669: }
670: for (i = 0; i < 2 * 2; ++i) C[i] = out[i];
671: (void)PetscLogFlops(243.0);
672: }
673: /* TODO Fix for aliasing of A and C */
674: static inline void DMPlex_PTAPReal_Internal(const PetscReal P[], PetscInt m, PetscInt n, const PetscScalar A[], PetscScalar C[])
675: {
676: PetscInt i, j, k, l;
677: for (i = 0; i < n; ++i) {
678: for (j = 0; j < n; ++j) {
679: C[i * n + j] = 0.;
680: for (k = 0; k < m; ++k) {
681: for (l = 0; l < m; ++l) C[i * n + j] += P[k * n + i] * A[k * m + l] * P[l * n + j];
682: }
683: }
684: }
685: (void)PetscLogFlops(243.0);
686: }
688: static inline void DMPlex_Transpose2D_Internal(PetscScalar A[])
689: {
690: PetscScalar tmp;
691: tmp = A[1];
692: A[1] = A[2];
693: A[2] = tmp;
694: }
695: static inline void DMPlex_Transpose3D_Internal(PetscScalar A[])
696: {
697: PetscScalar tmp;
698: tmp = A[1];
699: A[1] = A[3];
700: A[3] = tmp;
701: tmp = A[2];
702: A[2] = A[6];
703: A[6] = tmp;
704: tmp = A[5];
705: A[5] = A[7];
706: A[7] = tmp;
707: }
709: static inline void DMPlex_Invert2D_Internal(PetscReal invJ[], PetscReal J[], PetscReal detJ)
710: {
711: // Allow zero volume cells
712: const PetscReal invDet = detJ == 0 ? 1.0 : (PetscReal)1.0 / detJ;
714: invJ[0] = invDet * J[3];
715: invJ[1] = -invDet * J[1];
716: invJ[2] = -invDet * J[2];
717: invJ[3] = invDet * J[0];
718: (void)PetscLogFlops(5.0);
719: }
721: static inline void DMPlex_Invert3D_Internal(PetscReal invJ[], PetscReal J[], PetscReal detJ)
722: {
723: // Allow zero volume cells
724: const PetscReal invDet = detJ == 0 ? 1.0 : (PetscReal)1.0 / detJ;
726: invJ[0 * 3 + 0] = invDet * (J[1 * 3 + 1] * J[2 * 3 + 2] - J[1 * 3 + 2] * J[2 * 3 + 1]);
727: invJ[0 * 3 + 1] = invDet * (J[0 * 3 + 2] * J[2 * 3 + 1] - J[0 * 3 + 1] * J[2 * 3 + 2]);
728: invJ[0 * 3 + 2] = invDet * (J[0 * 3 + 1] * J[1 * 3 + 2] - J[0 * 3 + 2] * J[1 * 3 + 1]);
729: invJ[1 * 3 + 0] = invDet * (J[1 * 3 + 2] * J[2 * 3 + 0] - J[1 * 3 + 0] * J[2 * 3 + 2]);
730: invJ[1 * 3 + 1] = invDet * (J[0 * 3 + 0] * J[2 * 3 + 2] - J[0 * 3 + 2] * J[2 * 3 + 0]);
731: invJ[1 * 3 + 2] = invDet * (J[0 * 3 + 2] * J[1 * 3 + 0] - J[0 * 3 + 0] * J[1 * 3 + 2]);
732: invJ[2 * 3 + 0] = invDet * (J[1 * 3 + 0] * J[2 * 3 + 1] - J[1 * 3 + 1] * J[2 * 3 + 0]);
733: invJ[2 * 3 + 1] = invDet * (J[0 * 3 + 1] * J[2 * 3 + 0] - J[0 * 3 + 0] * J[2 * 3 + 1]);
734: invJ[2 * 3 + 2] = invDet * (J[0 * 3 + 0] * J[1 * 3 + 1] - J[0 * 3 + 1] * J[1 * 3 + 0]);
735: (void)PetscLogFlops(37.0);
736: }
738: static inline void DMPlex_Det2D_Internal(PetscReal *detJ, const PetscReal J[])
739: {
740: *detJ = J[0] * J[3] - J[1] * J[2];
741: (void)PetscLogFlops(3.0);
742: }
744: static inline void DMPlex_Det3D_Internal(PetscReal *detJ, const PetscReal J[])
745: {
746: *detJ = (J[0 * 3 + 0] * (J[1 * 3 + 1] * J[2 * 3 + 2] - J[1 * 3 + 2] * J[2 * 3 + 1]) + J[0 * 3 + 1] * (J[1 * 3 + 2] * J[2 * 3 + 0] - J[1 * 3 + 0] * J[2 * 3 + 2]) + J[0 * 3 + 2] * (J[1 * 3 + 0] * J[2 * 3 + 1] - J[1 * 3 + 1] * J[2 * 3 + 0]));
747: (void)PetscLogFlops(12.0);
748: }
750: static inline void DMPlex_Det2D_Scalar_Internal(PetscReal *detJ, const PetscScalar J[])
751: {
752: *detJ = PetscRealPart(J[0]) * PetscRealPart(J[3]) - PetscRealPart(J[1]) * PetscRealPart(J[2]);
753: (void)PetscLogFlops(3.0);
754: }
756: static inline void DMPlex_Det3D_Scalar_Internal(PetscReal *detJ, const PetscScalar J[])
757: {
758: *detJ = (PetscRealPart(J[0 * 3 + 0]) * (PetscRealPart(J[1 * 3 + 1]) * PetscRealPart(J[2 * 3 + 2]) - PetscRealPart(J[1 * 3 + 2]) * PetscRealPart(J[2 * 3 + 1])) + PetscRealPart(J[0 * 3 + 1]) * (PetscRealPart(J[1 * 3 + 2]) * PetscRealPart(J[2 * 3 + 0]) - PetscRealPart(J[1 * 3 + 0]) * PetscRealPart(J[2 * 3 + 2])) + PetscRealPart(J[0 * 3 + 2]) * (PetscRealPart(J[1 * 3 + 0]) * PetscRealPart(J[2 * 3 + 1]) - PetscRealPart(J[1 * 3 + 1]) * PetscRealPart(J[2 * 3 + 0])));
759: (void)PetscLogFlops(12.0);
760: }
762: static inline void DMPlex_WaxpyD_Internal(PetscInt dim, PetscReal a, const PetscReal *x, const PetscReal *y, PetscReal *w)
763: {
764: PetscInt d;
765: for (d = 0; d < dim; ++d) w[d] = a * x[d] + y[d];
766: }
768: static inline PetscReal DMPlex_DotD_Internal(PetscInt dim, const PetscScalar *x, const PetscReal *y)
769: {
770: PetscReal sum = 0.0;
771: PetscInt d;
772: for (d = 0; d < dim; ++d) sum += PetscRealPart(x[d]) * y[d];
773: return sum;
774: }
776: static inline PetscReal DMPlex_DotRealD_Internal(PetscInt dim, const PetscReal *x, const PetscReal *y)
777: {
778: PetscReal sum = 0.0;
779: PetscInt d;
780: for (d = 0; d < dim; ++d) sum += x[d] * y[d];
781: return sum;
782: }
784: static inline PetscReal DMPlex_NormD_Internal(PetscInt dim, const PetscReal *x)
785: {
786: PetscReal sum = 0.0;
787: PetscInt d;
788: for (d = 0; d < dim; ++d) sum += x[d] * x[d];
789: return PetscSqrtReal(sum);
790: }
792: static inline PetscReal DMPlex_DistD_Internal(PetscInt dim, const PetscScalar *x, const PetscScalar *y)
793: {
794: PetscReal sum = 0.0;
795: PetscInt d;
796: for (d = 0; d < dim; ++d) sum += PetscRealPart(PetscConj(x[d] - y[d]) * (x[d] - y[d]));
797: return PetscSqrtReal(sum);
798: }
800: static inline PetscReal DMPlex_DistRealD_Internal(PetscInt dim, const PetscReal *x, const PetscReal *y)
801: {
802: PetscReal sum = 0.0;
803: PetscInt d;
804: for (d = 0; d < dim; ++d) sum += (x[d] - y[d]) * (x[d] - y[d]);
805: return PetscSqrtReal(sum);
806: }
808: PETSC_INTERN PetscErrorCode DMPlexGetPointDualSpaceFEM(DM, PetscInt, PetscInt, PetscDualSpace *);
809: PETSC_INTERN PetscErrorCode DMPlexGetIndicesPoint_Internal(PetscSection, PetscBool, PetscInt, PetscInt, PetscInt *, PetscBool, const PetscInt[], const PetscInt[], PetscInt[]);
810: PETSC_INTERN PetscErrorCode DMPlexGetIndicesPointFields_Internal(PetscSection, PetscBool, PetscInt, PetscInt, PetscInt[], PetscBool, const PetscInt ***, PetscInt, const PetscInt[], PetscInt[]);
811: PETSC_INTERN PetscErrorCode DMPlexGetTransitiveClosure_Internal(DM, PetscInt, PetscInt, PetscBool, PetscInt *, PetscInt *[]);
812: PETSC_INTERN PetscErrorCode DMPlexMatSetClosure_Internal(DM, PetscSection, PetscSection, PetscBool, Mat, PetscInt, const PetscScalar[], InsertMode);
814: PETSC_SINGLE_LIBRARY_VISIBILITY_INTERNAL PetscErrorCode DMPlexGetAllCells_Internal(DM, IS *);
815: PETSC_INTERN PetscErrorCode DMPlexGetAllFaces_Internal(DM, IS *);
816: PETSC_EXTERN PetscErrorCode DMSNESGetFEGeom(DMField, IS, PetscQuadrature, PetscFEGeomMode, PetscFEGeom **);
817: PETSC_EXTERN PetscErrorCode DMSNESRestoreFEGeom(DMField, IS, PetscQuadrature, PetscBool, PetscFEGeom **);
818: PETSC_SINGLE_LIBRARY_VISIBILITY_INTERNAL PetscErrorCode DMPlexComputeResidual_Patch_Internal(DM, PetscSection, IS, PetscReal, Vec, Vec, Vec, void *);
819: PETSC_SINGLE_LIBRARY_VISIBILITY_INTERNAL PetscErrorCode DMPlexComputeJacobian_Patch_Internal(DM, PetscSection, PetscSection, IS, PetscReal, PetscReal, Vec, Vec, Mat, Mat, void *);
820: PETSC_INTERN PetscErrorCode DMCreateSubDomainDM_Plex(DM, DMLabel, PetscInt, IS *, DM *);
821: PETSC_INTERN PetscErrorCode DMPlexBasisTransformPoint_Internal(DM, DM, Vec, PetscInt, PetscBool[], PetscBool, PetscScalar *);
822: PETSC_INTERN PetscErrorCode DMPlexBasisTransformPointTensor_Internal(DM, DM, Vec, PetscInt, PetscBool, PetscInt, PetscScalar *);
823: PETSC_INTERN PetscErrorCode DMPlexBasisTransformApplyReal_Internal(DM, const PetscReal[], PetscBool, PetscInt, const PetscReal *, PetscReal *, void *);
824: PETSC_INTERN PetscErrorCode DMPlexBasisTransformApply_Internal(DM, const PetscReal[], PetscBool, PetscInt, const PetscScalar *, PetscScalar *, void *);
825: PETSC_INTERN PetscErrorCode DMCreateNeumannOverlap_Plex(DM, IS *, Mat *, PetscErrorCode (**)(Mat, PetscReal, Vec, Vec, PetscReal, IS, void *), void **);
826: PETSC_INTERN PetscErrorCode DMPlexMarkBoundaryFaces_Internal(DM, PetscInt, PetscInt, DMLabel, PetscBool);
827: PETSC_INTERN PetscErrorCode DMPlexDistributeOverlap_Internal(DM, PetscInt, MPI_Comm, const char *, PetscSF *, DM *);
829: PETSC_INTERN PetscErrorCode DMPlexInterpolateFaces_Internal(DM, PetscInt, DM);
831: PETSC_INTERN PetscErrorCode DMPlexMarkSubmesh_Interpolated(DM, DMLabel, PetscInt, PetscBool, PetscBool, DMLabel, DM);
833: PETSC_INTERN PetscErrorCode DMPeriodicCoordinateSetUp_Internal(DM);
835: /* Functions in the vtable */
836: PETSC_INTERN PetscErrorCode DMCreateInterpolation_Plex(DM dmCoarse, DM dmFine, Mat *interpolation, Vec *scaling);
837: PETSC_INTERN PetscErrorCode DMCreateInjection_Plex(DM dmCoarse, DM dmFine, Mat *mat);
838: PETSC_INTERN PetscErrorCode DMCreateMassMatrix_Plex(DM dmCoarse, DM dmFine, Mat *mat);
839: PETSC_INTERN PetscErrorCode DMCreateMassMatrixLumped_Plex(DM, Vec *, Vec *);
840: PETSC_INTERN PetscErrorCode DMCreateGradientMatrix_Plex(DM dmCoarse, DM dmFine, Mat *mat);
841: PETSC_INTERN PetscErrorCode DMCreateLocalSection_Plex(DM dm);
842: PETSC_INTERN PetscErrorCode DMCreateDefaultConstraints_Plex(DM dm);
843: PETSC_INTERN PetscErrorCode DMCreateMatrix_Plex(DM dm, Mat *J);
844: PETSC_INTERN PetscErrorCode DMCreateCoordinateDM_Plex(DM dm, DM *cdm);
845: PETSC_INTERN PetscErrorCode DMCreateCellCoordinateDM_Plex(DM dm, DM *cdm);
846: PETSC_INTERN PetscErrorCode DMCreateCoordinateField_Plex(DM dm, DMField *field);
847: PETSC_INTERN PetscErrorCode DMClone_Plex(DM dm, DM *newdm);
848: PETSC_INTERN PetscErrorCode DMSetUp_Plex(DM dm);
849: PETSC_INTERN PetscErrorCode DMDestroy_Plex(DM dm);
850: PETSC_INTERN PetscErrorCode DMView_Plex(DM dm, PetscViewer viewer);
851: PETSC_INTERN PetscErrorCode DMLoad_Plex(DM dm, PetscViewer viewer);
852: PETSC_INTERN PetscErrorCode DMCreateSubDM_Plex(DM dm, PetscInt numFields, const PetscInt fields[], IS *is, DM *subdm);
853: PETSC_INTERN PetscErrorCode DMCreateSuperDM_Plex(DM dms[], PetscInt len, IS **is, DM *superdm);
854: PETSC_INTERN PetscErrorCode DMCreateDomainDecompositionScatters_Plex(DM, PetscInt, DM *, VecScatter **, VecScatter **, VecScatter **);
855: PETSC_INTERN PetscErrorCode DMCreateDomainDecomposition_Plex(DM, PetscInt *, char ***, IS **, IS **, DM **);
856: PETSC_INTERN PetscErrorCode DMCreateSectionPermutation_Plex(DM dm, IS *permutation, PetscBT *blockStarts);
858: // Coordinate mapping functions
859: PETSC_INTERN void coordMap_identity(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]);
860: PETSC_INTERN void coordMap_shear(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]);
861: PETSC_INTERN void coordMap_flare(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]);
862: PETSC_INTERN void coordMap_annulus(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]);
863: PETSC_INTERN void coordMap_shell(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]);
864: PETSC_INTERN void coordMap_sinusoid(PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], const PetscInt[], const PetscInt[], const PetscScalar[], const PetscScalar[], const PetscScalar[], PetscReal, const PetscReal[], PetscInt, const PetscScalar[], PetscScalar[]);
866: PETSC_INTERN PetscErrorCode DMSnapToGeomModel_EGADS(DM, PetscInt, PetscInt, const PetscScalar[], PetscScalar[]);
868: // FIXME: DM with Attached CAD Models (STEP, IGES, BRep, EGADS, EGADSlite)
869: PETSC_EXTERN PetscErrorCode DMPlexSnapToGeomModel(DM, PetscInt, PetscInt, const PetscScalar[], PetscScalar[]);
871: // Coordinate <-> Reference mapping functions
872: PETSC_INTERN PetscErrorCode DMPlexCoordinatesToReference_FE(DM, PetscFE, PetscInt, PetscInt, const PetscReal[], PetscReal[], Vec, PetscInt, PetscInt, PetscInt, PetscReal *);
873: PETSC_INTERN PetscErrorCode DMPlexReferenceToCoordinates_FE(DM, PetscFE, PetscInt, PetscInt, const PetscReal[], PetscReal[], Vec, PetscInt, PetscInt);