Actual source code: dmperiodicity.c
1: #include <petsc/private/dmimpl.h>
3: #include <petscdmplex.h>
5: /*@C
6: DMGetPeriodicity - Get the description of mesh periodicity
8: Input Parameter:
9: . dm - The `DM` object
11: Output Parameters:
12: + maxCell - Over distances greater than this, we can assume a point has crossed over to another sheet, when trying to localize cell coordinates
13: . Lstart - If we assume the mesh is a torus, this is the start of each coordinate, or `NULL` for 0.0
14: - L - If we assume the mesh is a torus, this is the length of each coordinate, otherwise it is < 0.0
16: Level: developer
18: .seealso: `DM`
19: @*/
20: PetscErrorCode DMGetPeriodicity(DM dm, const PetscReal **maxCell, const PetscReal **Lstart, const PetscReal **L)
21: {
22: PetscFunctionBegin;
24: if (maxCell) *maxCell = dm->maxCell;
25: if (Lstart) *Lstart = dm->Lstart;
26: if (L) *L = dm->L;
27: PetscFunctionReturn(PETSC_SUCCESS);
28: }
30: /*@C
31: DMSetPeriodicity - Set the description of mesh periodicity
33: Input Parameters:
34: + dm - The `DM` object
35: . maxCell - Over distances greater than this, we can assume a point has crossed over to another sheet, when trying to localize cell coordinates. Pass `NULL` to remove such information.
36: . Lstart - If we assume the mesh is a torus, this is the start of each coordinate, or `NULL` for 0.0
37: - L - If we assume the mesh is a torus, this is the length of each coordinate, otherwise it is < 0.0
39: Level: developer
41: .seealso: `DM`, `DMGetPeriodicity()`
42: @*/
43: PetscErrorCode DMSetPeriodicity(DM dm, const PetscReal maxCell[], const PetscReal Lstart[], const PetscReal L[])
44: {
45: PetscInt dim, d;
47: PetscFunctionBegin;
49: if (maxCell) PetscAssertPointer(maxCell, 2);
50: if (Lstart) PetscAssertPointer(Lstart, 3);
51: if (L) PetscAssertPointer(L, 4);
52: PetscCall(DMGetDimension(dm, &dim));
53: if (maxCell) {
54: if (!dm->maxCell) PetscCall(PetscMalloc1(dim, &dm->maxCell));
55: for (d = 0; d < dim; ++d) dm->maxCell[d] = maxCell[d];
56: } else { /* remove maxCell information to disable automatic computation of localized vertices */
57: PetscCall(PetscFree(dm->maxCell));
58: dm->maxCell = NULL;
59: }
60: if (Lstart) {
61: if (!dm->Lstart) PetscCall(PetscMalloc1(dim, &dm->Lstart));
62: for (d = 0; d < dim; ++d) dm->Lstart[d] = Lstart[d];
63: } else { /* remove L information to disable automatic computation of localized vertices */
64: PetscCall(PetscFree(dm->Lstart));
65: dm->Lstart = NULL;
66: }
67: if (L) {
68: if (!dm->L) PetscCall(PetscMalloc1(dim, &dm->L));
69: for (d = 0; d < dim; ++d) dm->L[d] = L[d];
70: } else { /* remove L information to disable automatic computation of localized vertices */
71: PetscCall(PetscFree(dm->L));
72: dm->L = NULL;
73: }
74: PetscCheck((dm->maxCell && dm->L) || (!dm->maxCell && !dm->L), PetscObjectComm((PetscObject)dm), PETSC_ERR_ARG_WRONG, "Cannot set only one of maxCell/L");
75: PetscFunctionReturn(PETSC_SUCCESS);
76: }
78: /*@
79: DMLocalizeCoordinate - If a mesh is periodic (a torus with lengths L_i, some of which can be infinite), project the coordinate onto [0, L_i) in each dimension.
81: Input Parameters:
82: + dm - The `DM`
83: . in - The input coordinate point (dim numbers)
84: - endpoint - Include the endpoint L_i
86: Output Parameter:
87: . out - The localized coordinate point (dim numbers)
89: Level: developer
91: .seealso: `DM`, `DMLocalizeCoordinates()`, `DMLocalizeAddCoordinate()`
92: @*/
93: PetscErrorCode DMLocalizeCoordinate(DM dm, const PetscScalar in[], PetscBool endpoint, PetscScalar out[])
94: {
95: PetscInt dim, d;
97: PetscFunctionBegin;
98: PetscCall(DMGetCoordinateDim(dm, &dim));
99: if (!dm->maxCell) {
100: for (d = 0; d < dim; ++d) out[d] = in[d];
101: } else {
102: if (endpoint) {
103: for (d = 0; d < dim; ++d) {
104: if ((PetscAbsReal(PetscRealPart(in[d]) / dm->L[d] - PetscFloorReal(PetscRealPart(in[d]) / dm->L[d])) < PETSC_SMALL) && (PetscRealPart(in[d]) / dm->L[d] > PETSC_SMALL)) {
105: out[d] = in[d] - dm->L[d] * (PetscFloorReal(PetscRealPart(in[d]) / dm->L[d]) - 1);
106: } else {
107: out[d] = in[d] - dm->L[d] * PetscFloorReal(PetscRealPart(in[d]) / dm->L[d]);
108: }
109: }
110: } else {
111: for (d = 0; d < dim; ++d) out[d] = in[d] - dm->L[d] * PetscFloorReal(PetscRealPart(in[d]) / dm->L[d]);
112: }
113: }
114: PetscFunctionReturn(PETSC_SUCCESS);
115: }
117: /*
118: DMLocalizeCoordinate_Internal - If a mesh is periodic, and the input point is far from the anchor, pick the coordinate sheet of the torus which moves it closer.
120: Input Parameters:
121: + dm - The `DM`
122: . dim - The spatial dimension
123: . anchor - The anchor point, the input point can be no more than maxCell away from it
124: - in - The input coordinate point (dim numbers)
126: Output Parameter:
127: . out - The localized coordinate point (dim numbers)
129: Level: developer
131: Note:
132: This is meant to get a set of coordinates close to each other, as in a cell. The anchor is usually the one of the vertices on a containing cell
134: .seealso: `DM`, `DMLocalizeCoordinates()`, `DMLocalizeAddCoordinate()`
135: */
136: PetscErrorCode DMLocalizeCoordinate_Internal(DM dm, PetscInt dim, const PetscScalar anchor[], const PetscScalar in[], PetscScalar out[])
137: {
138: PetscInt d;
140: PetscFunctionBegin;
141: if (!dm->maxCell) {
142: for (d = 0; d < dim; ++d) out[d] = in[d];
143: } else {
144: for (d = 0; d < dim; ++d) {
145: if ((dm->L[d] > 0.0) && (PetscAbsScalar(anchor[d] - in[d]) > dm->maxCell[d])) {
146: out[d] = PetscRealPart(anchor[d]) > PetscRealPart(in[d]) ? dm->L[d] + in[d] : in[d] - dm->L[d];
147: } else {
148: out[d] = in[d];
149: }
150: }
151: }
152: PetscFunctionReturn(PETSC_SUCCESS);
153: }
155: PetscErrorCode DMLocalizeCoordinateReal_Internal(DM dm, PetscInt dim, const PetscReal anchor[], const PetscReal in[], PetscReal out[])
156: {
157: PetscInt d;
159: PetscFunctionBegin;
160: if (!dm->maxCell) {
161: for (d = 0; d < dim; ++d) out[d] = in[d];
162: } else {
163: for (d = 0; d < dim; ++d) {
164: if ((dm->L[d] > 0.0) && (PetscAbsReal(anchor[d] - in[d]) > dm->maxCell[d])) {
165: out[d] = anchor[d] > in[d] ? dm->L[d] + in[d] : in[d] - dm->L[d];
166: } else {
167: out[d] = in[d];
168: }
169: }
170: }
171: PetscFunctionReturn(PETSC_SUCCESS);
172: }
174: /*
175: DMLocalizeAddCoordinate_Internal - If a mesh is periodic, and the input point is far from the anchor, pick the coordinate sheet of the torus which moves it closer.
177: Input Parameters:
178: + dm - The `DM`
179: . dim - The spatial dimension
180: . anchor - The anchor point, the input point can be no more than maxCell away from it
181: . in - The input coordinate delta (dim numbers)
182: - out - The input coordinate point (dim numbers)
184: Output Parameter:
185: . out - The localized coordinate in + out
187: Level: developer
189: Note:
190: This is meant to get a set of coordinates close to each other, as in a cell. The anchor is usually one of the vertices on a containing cell
192: .seealso: `DM`, `DMLocalizeCoordinates()`, `DMLocalizeCoordinate()`
193: */
194: PetscErrorCode DMLocalizeAddCoordinate_Internal(DM dm, PetscInt dim, const PetscScalar anchor[], const PetscScalar in[], PetscScalar out[])
195: {
196: PetscInt d;
198: PetscFunctionBegin;
199: if (!dm->maxCell) {
200: for (d = 0; d < dim; ++d) out[d] += in[d];
201: } else {
202: for (d = 0; d < dim; ++d) {
203: const PetscReal maxC = dm->maxCell[d];
205: if ((dm->L[d] > 0.0) && (PetscAbsScalar(anchor[d] - in[d]) > maxC)) {
206: const PetscScalar newCoord = PetscRealPart(anchor[d]) > PetscRealPart(in[d]) ? dm->L[d] + in[d] : in[d] - dm->L[d];
208: if (PetscAbsScalar(newCoord - anchor[d]) > maxC)
209: SETERRQ(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "%" PetscInt_FMT "-Coordinate %g more than %g away from anchor %g", d, (double)PetscRealPart(in[d]), (double)maxC, (double)PetscRealPart(anchor[d]));
210: out[d] += newCoord;
211: } else {
212: out[d] += in[d];
213: }
214: }
215: }
216: PetscFunctionReturn(PETSC_SUCCESS);
217: }
219: /*@
220: DMGetCoordinatesLocalizedLocal - Check if the `DM` coordinates have been localized for cells on this process
222: Not Collective
224: Input Parameter:
225: . dm - The `DM`
227: Output Parameter:
228: . areLocalized - `PETSC_TRUE` if localized
230: Level: developer
232: .seealso: `DM`, `DMLocalizeCoordinates()`, `DMGetCoordinatesLocalized()`, `DMSetPeriodicity()`
233: @*/
234: PetscErrorCode DMGetCoordinatesLocalizedLocal(DM dm, PetscBool *areLocalized)
235: {
236: PetscFunctionBegin;
238: PetscAssertPointer(areLocalized, 2);
239: *areLocalized = dm->coordinates[1].dim < 0 ? PETSC_FALSE : PETSC_TRUE;
240: PetscFunctionReturn(PETSC_SUCCESS);
241: }
243: /*@
244: DMGetCoordinatesLocalized - Check if the `DM` coordinates have been localized for cells
246: Collective
248: Input Parameter:
249: . dm - The `DM`
251: Output Parameter:
252: . areLocalized - `PETSC_TRUE` if localized
254: Level: developer
256: .seealso: `DM`, `DMLocalizeCoordinates()`, `DMSetPeriodicity()`, `DMGetCoordinatesLocalizedLocal()`
257: @*/
258: PetscErrorCode DMGetCoordinatesLocalized(DM dm, PetscBool *areLocalized)
259: {
260: PetscBool localized;
262: PetscFunctionBegin;
264: PetscAssertPointer(areLocalized, 2);
265: PetscCall(DMGetCoordinatesLocalizedLocal(dm, &localized));
266: PetscCall(MPIU_Allreduce(&localized, areLocalized, 1, MPIU_BOOL, MPI_LOR, PetscObjectComm((PetscObject)dm)));
267: PetscFunctionReturn(PETSC_SUCCESS);
268: }
270: /*@
271: DMLocalizeCoordinates - If a mesh is periodic, create local coordinates for cells having periodic faces
273: Collective
275: Input Parameter:
276: . dm - The `DM`
278: Level: developer
280: .seealso: `DM`, `DMSetPeriodicity()`, `DMLocalizeCoordinate()`, `DMLocalizeAddCoordinate()`
281: @*/
282: PetscErrorCode DMLocalizeCoordinates(DM dm)
283: {
284: DM cdm, cdgdm, cplex, plex;
285: PetscSection cs, csDG;
286: Vec coordinates, cVec;
287: PetscScalar *coordsDG, *anchor, *localized;
288: const PetscReal *Lstart, *L;
289: PetscInt Nc, vStart, vEnd, sStart, sEnd, newStart = PETSC_MAX_INT, newEnd = PETSC_MIN_INT, bs, coordSize;
290: PetscBool isLocalized, sparseLocalize = dm->sparseLocalize, useDG = PETSC_FALSE, useDGGlobal;
291: PetscInt maxHeight = 0, h;
292: PetscInt *pStart = NULL, *pEnd = NULL;
293: MPI_Comm comm;
295: PetscFunctionBegin;
297: PetscCall(DMGetPeriodicity(dm, NULL, &Lstart, &L));
298: /* Cannot automatically localize without L and maxCell right now */
299: if (!L) PetscFunctionReturn(PETSC_SUCCESS);
300: PetscCall(PetscObjectGetComm((PetscObject)dm, &comm));
301: PetscCall(DMGetCoordinatesLocalized(dm, &isLocalized));
302: if (isLocalized) PetscFunctionReturn(PETSC_SUCCESS);
304: PetscCall(DMGetCoordinateDM(dm, &cdm));
305: PetscCall(DMConvert(dm, DMPLEX, &plex));
306: PetscCall(DMConvert(cdm, DMPLEX, &cplex));
307: if (cplex) {
308: PetscCall(DMPlexGetDepthStratum(cplex, 0, &vStart, &vEnd));
309: PetscCall(DMPlexGetMaxProjectionHeight(cplex, &maxHeight));
310: PetscCall(DMGetWorkArray(dm, 2 * (maxHeight + 1), MPIU_INT, &pStart));
311: pEnd = &pStart[maxHeight + 1];
312: newStart = vStart;
313: newEnd = vEnd;
314: for (h = 0; h <= maxHeight; h++) {
315: PetscCall(DMPlexGetHeightStratum(cplex, h, &pStart[h], &pEnd[h]));
316: newStart = PetscMin(newStart, pStart[h]);
317: newEnd = PetscMax(newEnd, pEnd[h]);
318: }
319: } else SETERRQ(comm, PETSC_ERR_ARG_WRONG, "Coordinate localization requires a DMPLEX coordinate DM");
320: PetscCall(DMGetCoordinatesLocal(dm, &coordinates));
321: PetscCheck(coordinates, comm, PETSC_ERR_SUP, "Missing local coordinate vector");
322: PetscCall(DMGetCoordinateSection(dm, &cs));
323: PetscCall(VecGetBlockSize(coordinates, &bs));
324: PetscCall(PetscSectionGetChart(cs, &sStart, &sEnd));
326: PetscCall(PetscSectionCreate(comm, &csDG));
327: PetscCall(PetscSectionSetNumFields(csDG, 1));
328: PetscCall(PetscSectionGetFieldComponents(cs, 0, &Nc));
329: PetscCall(PetscSectionSetFieldComponents(csDG, 0, Nc));
330: PetscCall(PetscSectionSetChart(csDG, newStart, newEnd));
331: PetscCheck(bs == Nc, comm, PETSC_ERR_ARG_INCOMP, "Coordinate block size %" PetscInt_FMT " != %" PetscInt_FMT " number of components", bs, Nc);
333: PetscCall(DMGetWorkArray(dm, 2 * Nc, MPIU_SCALAR, &anchor));
334: localized = &anchor[Nc];
335: for (h = 0; h <= maxHeight; h++) {
336: PetscInt cStart = pStart[h], cEnd = pEnd[h], c;
338: for (c = cStart; c < cEnd; ++c) {
339: PetscScalar *cellCoords = NULL;
340: DMPolytopeType ct;
341: PetscInt dof, d, p;
343: PetscCall(DMPlexGetCellType(plex, c, &ct));
344: if (ct == DM_POLYTOPE_FV_GHOST) continue;
345: PetscCall(DMPlexVecGetClosure(cplex, cs, coordinates, c, &dof, &cellCoords));
346: PetscCheck(!(dof % Nc), comm, PETSC_ERR_ARG_INCOMP, "Coordinate size on cell %" PetscInt_FMT " closure %" PetscInt_FMT " not divisible by %" PetscInt_FMT " number of components", c, dof, Nc);
347: for (d = 0; d < Nc; ++d) anchor[d] = cellCoords[d];
348: for (p = 0; p < dof / Nc; ++p) {
349: PetscCall(DMLocalizeCoordinate_Internal(dm, Nc, anchor, &cellCoords[p * Nc], localized));
350: for (d = 0; d < Nc; ++d)
351: if (cellCoords[p * Nc + d] != localized[d]) break;
352: if (d < Nc) break;
353: }
354: if (p < dof / Nc) useDG = PETSC_TRUE;
355: if (p < dof / Nc || !sparseLocalize) {
356: PetscCall(PetscSectionSetDof(csDG, c, dof));
357: PetscCall(PetscSectionSetFieldDof(csDG, c, 0, dof));
358: }
359: PetscCall(DMPlexVecRestoreClosure(cplex, cs, coordinates, c, &dof, &cellCoords));
360: }
361: }
362: PetscCall(MPIU_Allreduce(&useDG, &useDGGlobal, 1, MPIU_BOOL, MPI_LOR, comm));
363: if (!useDGGlobal) goto end;
365: PetscCall(PetscSectionSetUp(csDG));
366: PetscCall(PetscSectionGetStorageSize(csDG, &coordSize));
367: PetscCall(VecCreate(PETSC_COMM_SELF, &cVec));
368: PetscCall(PetscObjectSetName((PetscObject)cVec, "coordinates"));
369: PetscCall(VecSetBlockSize(cVec, bs));
370: PetscCall(VecSetSizes(cVec, coordSize, PETSC_DETERMINE));
371: PetscCall(VecSetType(cVec, VECSTANDARD));
372: PetscCall(VecGetArray(cVec, &coordsDG));
373: for (h = 0; h <= maxHeight; h++) {
374: PetscInt cStart = pStart[h], cEnd = pEnd[h], c;
376: for (c = cStart; c < cEnd; ++c) {
377: PetscScalar *cellCoords = NULL;
378: PetscInt p = 0, q, dof, cdof, d, offDG;
380: PetscCall(PetscSectionGetDof(csDG, c, &cdof));
381: if (!cdof) continue;
382: PetscCall(DMPlexVecGetClosure(cplex, cs, coordinates, c, &dof, &cellCoords));
383: PetscCall(PetscSectionGetOffset(csDG, c, &offDG));
384: // TODO The coordinates are set in closure order, which might not be the tensor order
385: for (q = 0; q < dof / Nc; ++q) {
386: // Select a trial anchor
387: for (d = 0; d < Nc; ++d) anchor[d] = cellCoords[q * Nc + d];
388: for (p = 0; p < dof / Nc; ++p) {
389: PetscCall(DMLocalizeCoordinate_Internal(dm, Nc, anchor, &cellCoords[p * Nc], &coordsDG[offDG + p * Nc]));
390: // We need the cell to fit into the torus [lower, lower+L)
391: for (d = 0; d < Nc; ++d)
392: if (L[d] > 0. && ((PetscRealPart(coordsDG[offDG + p * Nc + d]) < (Lstart ? Lstart[d] : 0.)) || (PetscRealPart(coordsDG[offDG + p * Nc + d]) > (Lstart ? Lstart[d] : 0.) + L[d]))) break;
393: if (d < Nc) break;
394: }
395: if (p == dof / Nc) break;
396: }
397: PetscCheck(p == dof / Nc, PETSC_COMM_SELF, PETSC_ERR_ARG_WRONG, "Cell %" PetscInt_FMT " does not fit into the torus %s[0, L]", c, Lstart ? "Lstart + " : "");
398: PetscCall(DMPlexVecRestoreClosure(cplex, cs, coordinates, c, &dof, &cellCoords));
399: }
400: }
401: PetscCall(VecRestoreArray(cVec, &coordsDG));
402: PetscCall(DMClone(cdm, &cdgdm));
403: PetscCall(DMSetCellCoordinateDM(dm, cdgdm));
404: PetscCall(DMSetCellCoordinateSection(dm, PETSC_DETERMINE, csDG));
405: PetscCall(DMSetCellCoordinatesLocal(dm, cVec));
406: PetscCall(VecDestroy(&cVec));
407: // Convert the discretization
408: {
409: PetscFE fe, dgfe;
410: PetscSpace P;
411: PetscDualSpace Q, dgQ;
412: PetscQuadrature q, fq;
413: PetscClassId id;
415: PetscCall(DMGetField(cdm, 0, NULL, (PetscObject *)&fe));
416: PetscCall(PetscObjectGetClassId((PetscObject)fe, &id));
417: if (id == PETSCFE_CLASSID) {
418: PetscCall(PetscFEGetBasisSpace(fe, &P));
419: PetscCall(PetscObjectReference((PetscObject)P));
420: PetscCall(PetscFEGetDualSpace(fe, &Q));
421: PetscCall(PetscDualSpaceDuplicate(Q, &dgQ));
422: PetscCall(PetscDualSpaceLagrangeSetContinuity(dgQ, PETSC_FALSE));
423: PetscCall(PetscDualSpaceSetUp(dgQ));
424: PetscCall(PetscFEGetQuadrature(fe, &q));
425: PetscCall(PetscObjectReference((PetscObject)q));
426: PetscCall(PetscFEGetFaceQuadrature(fe, &fq));
427: PetscCall(PetscObjectReference((PetscObject)fq));
428: PetscCall(PetscFECreateFromSpaces(P, dgQ, q, fq, &dgfe));
429: PetscCall(DMSetField(cdgdm, 0, NULL, (PetscObject)dgfe));
430: PetscCall(PetscFEDestroy(&dgfe));
431: PetscCall(DMCreateDS(cdgdm));
432: }
433: }
434: PetscCall(DMDestroy(&cdgdm));
436: end:
437: PetscCall(DMRestoreWorkArray(dm, 2 * bs, MPIU_SCALAR, &anchor));
438: PetscCall(DMRestoreWorkArray(dm, 2 * (maxHeight + 1), MPIU_INT, &pStart));
439: PetscCall(PetscSectionDestroy(&csDG));
440: PetscCall(DMDestroy(&plex));
441: PetscCall(DMDestroy(&cplex));
442: PetscFunctionReturn(PETSC_SUCCESS);
443: }