Actual source code: plexrefine.c

  1: #include <petsc/private/dmpleximpl.h>
  2: #include <petsc/private/petscfeimpl.h>

  4: #include <petscdmplextransform.h>
  5: #include <petscsf.h>

  7: /*@
  8:   DMPlexCreateProcessSF - Create an `PetscSF` which just has process connectivity

 10:   Collective

 12:   Input Parameters:
 13: + dm      - The `DM`
 14: - sfPoint - The `PetscSF` which encodes point connectivity

 16:   Output Parameters:
 17: + processRanks - A list of process neighbors, or `NULL`
 18: - sfProcess    - An `PetscSF` encoding the process connectivity, or `NULL`

 20:   Level: developer

 22: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `PetscSF`, `PetscSFCreate()`, `DMPlexCreateTwoSidedProcessSF()`
 23: @*/
 24: PetscErrorCode DMPlexCreateProcessSF(DM dm, PetscSF sfPoint, IS *processRanks, PetscSF *sfProcess)
 25: {
 26:   PetscInt           numRoots, numLeaves, l;
 27:   const PetscInt    *localPoints;
 28:   const PetscSFNode *remotePoints;
 29:   PetscInt          *localPointsNew;
 30:   PetscSFNode       *remotePointsNew;
 31:   PetscMPIInt       *ranks;
 32:   PetscInt          *ranksNew;
 33:   PetscMPIInt        size;

 35:   PetscFunctionBegin;
 38:   if (processRanks) PetscAssertPointer(processRanks, 3);
 39:   if (sfProcess) PetscAssertPointer(sfProcess, 4);
 40:   PetscCallMPI(MPI_Comm_size(PetscObjectComm((PetscObject)dm), &size));
 41:   PetscCall(PetscSFGetGraph(sfPoint, &numRoots, &numLeaves, &localPoints, &remotePoints));
 42:   PetscCall(PetscMalloc1(numLeaves, &ranks));
 43:   for (l = 0; l < numLeaves; ++l) ranks[l] = (PetscMPIInt)remotePoints[l].rank;
 44:   PetscCall(PetscSortRemoveDupsMPIInt(&numLeaves, ranks));
 45:   PetscCall(PetscMalloc1(numLeaves, &ranksNew));
 46:   PetscCall(PetscMalloc1(numLeaves, &localPointsNew));
 47:   PetscCall(PetscMalloc1(numLeaves, &remotePointsNew));
 48:   for (l = 0; l < numLeaves; ++l) {
 49:     ranksNew[l]              = ranks[l];
 50:     localPointsNew[l]        = l;
 51:     remotePointsNew[l].index = 0;
 52:     remotePointsNew[l].rank  = ranksNew[l];
 53:   }
 54:   PetscCall(PetscFree(ranks));
 55:   if (processRanks) PetscCall(ISCreateGeneral(PetscObjectComm((PetscObject)dm), numLeaves, ranksNew, PETSC_OWN_POINTER, processRanks));
 56:   else PetscCall(PetscFree(ranksNew));
 57:   if (sfProcess) {
 58:     PetscCall(PetscSFCreate(PetscObjectComm((PetscObject)dm), sfProcess));
 59:     PetscCall(PetscObjectSetName((PetscObject)*sfProcess, "Process SF"));
 60:     PetscCall(PetscSFSetFromOptions(*sfProcess));
 61:     PetscCall(PetscSFSetGraph(*sfProcess, size, numLeaves, localPointsNew, PETSC_OWN_POINTER, remotePointsNew, PETSC_OWN_POINTER));
 62:   }
 63:   PetscFunctionReturn(PETSC_SUCCESS);
 64: }

 66: /*@
 67:   DMPlexCreateCoarsePointIS - Creates an `IS` covering the coarse `DM` chart with the fine points as data

 69:   Collective

 71:   Input Parameter:
 72: . dm - The coarse `DM`

 74:   Output Parameter:
 75: . fpointIS - The `IS` of all the fine points which exist in the original coarse mesh

 77:   Level: developer

 79: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `IS`, `DMRefine()`, `DMPlexSetRefinementUniform()`, `DMPlexGetSubpointIS()`
 80: @*/
 81: PetscErrorCode DMPlexCreateCoarsePointIS(DM dm, IS *fpointIS)
 82: {
 83:   DMPlexTransform tr;
 84:   PetscInt       *fpoints;
 85:   PetscInt        pStart, pEnd, p, vStart, vEnd, v;

 87:   PetscFunctionBegin;
 88:   PetscCall(DMPlexGetChart(dm, &pStart, &pEnd));
 89:   PetscCall(DMPlexGetDepthStratum(dm, 0, &vStart, &vEnd));
 90:   PetscCall(DMPlexTransformCreate(PetscObjectComm((PetscObject)dm), &tr));
 91:   PetscCall(DMPlexTransformSetUp(tr));
 92:   PetscCall(PetscMalloc1(pEnd - pStart, &fpoints));
 93:   for (p = 0; p < pEnd - pStart; ++p) fpoints[p] = -1;
 94:   for (v = vStart; v < vEnd; ++v) {
 95:     PetscInt vNew = -1; /* quiet overzealous may be used uninitialized check */

 97:     PetscCall(DMPlexTransformGetTargetPoint(tr, DM_POLYTOPE_POINT, DM_POLYTOPE_POINT, p, 0, &vNew));
 98:     fpoints[v - pStart] = vNew;
 99:   }
100:   PetscCall(DMPlexTransformDestroy(&tr));
101:   PetscCall(ISCreateGeneral(PETSC_COMM_SELF, pEnd - pStart, fpoints, PETSC_OWN_POINTER, fpointIS));
102:   PetscFunctionReturn(PETSC_SUCCESS);
103: }

105: /*@
106:   DMPlexSetTransformType - Set the transform type for uniform refinement

108:   Input Parameters:
109: + dm   - The `DM`
110: - type - The transform type for uniform refinement

112:   Level: developer

114: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMPlexTransformType`, `DMRefine()`, `DMPlexGetTransformType()`, `DMPlexSetRefinementUniform()`
115: @*/
116: PetscErrorCode DMPlexSetTransformType(DM dm, DMPlexTransformType type)
117: {
118:   DM_Plex *mesh = (DM_Plex *)dm->data;

120:   PetscFunctionBegin;
122:   if (type) PetscAssertPointer(type, 2);
123:   PetscCall(PetscFree(mesh->transformType));
124:   PetscCall(PetscStrallocpy(type, &mesh->transformType));
125:   PetscFunctionReturn(PETSC_SUCCESS);
126: }

128: /*@C
129:   DMPlexGetTransformType - Retrieve the transform type for uniform refinement

131:   Input Parameter:
132: . dm - The `DM`

134:   Output Parameter:
135: . type - The transform type for uniform refinement

137:   Level: developer

139: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMPlexTransformType`, `DMRefine()`, `DMPlexSetTransformType()`, `DMPlexGetRefinementUniform()`
140: @*/
141: PetscErrorCode DMPlexGetTransformType(DM dm, DMPlexTransformType *type)
142: {
143:   DM_Plex *mesh = (DM_Plex *)dm->data;

145:   PetscFunctionBegin;
147:   PetscAssertPointer(type, 2);
148:   *type = mesh->transformType;
149:   PetscFunctionReturn(PETSC_SUCCESS);
150: }

152: PetscErrorCode DMPlexSetTransform(DM dm, DMPlexTransform tr)
153: {
154:   DM_Plex *mesh = (DM_Plex *)dm->data;

156:   PetscFunctionBegin;
159:   PetscCall(PetscObjectReference((PetscObject)tr));
160:   PetscCall(DMPlexTransformDestroy(&mesh->transform));
161:   mesh->transform = tr;
162:   PetscFunctionReturn(PETSC_SUCCESS);
163: }

165: PetscErrorCode DMPlexGetTransform(DM dm, DMPlexTransform *tr)
166: {
167:   DM_Plex *mesh = (DM_Plex *)dm->data;

169:   PetscFunctionBegin;
171:   PetscAssertPointer(tr, 2);
172:   *tr = mesh->transform;
173:   PetscFunctionReturn(PETSC_SUCCESS);
174: }

176: PetscErrorCode DMPlexSetSaveTransform(DM dm, PetscBool save)
177: {
178:   DM_Plex *mesh = (DM_Plex *)dm->data;

180:   PetscFunctionBegin;
182:   mesh->saveTransform = save;
183:   PetscFunctionReturn(PETSC_SUCCESS);
184: }

186: PetscErrorCode DMPlexGetSaveTransform(DM dm, PetscBool *save)
187: {
188:   DM_Plex *mesh = (DM_Plex *)dm->data;

190:   PetscFunctionBegin;
192:   PetscAssertPointer(save, 2);
193:   *save = mesh->saveTransform;
194:   PetscFunctionReturn(PETSC_SUCCESS);
195: }

197: /*@
198:   DMPlexSetRefinementUniform - Set the flag for uniform refinement

200:   Input Parameters:
201: + dm                - The `DM`
202: - refinementUniform - The flag for uniform refinement

204:   Level: developer

206: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMRefine()`, `DMPlexGetRefinementUniform()`, `DMPlexGetRefinementLimit()`, `DMPlexSetRefinementLimit()`
207: @*/
208: PetscErrorCode DMPlexSetRefinementUniform(DM dm, PetscBool refinementUniform)
209: {
210:   DM_Plex *mesh = (DM_Plex *)dm->data;

212:   PetscFunctionBegin;
214:   mesh->refinementUniform = refinementUniform;
215:   PetscFunctionReturn(PETSC_SUCCESS);
216: }

218: /*@
219:   DMPlexGetRefinementUniform - Retrieve the flag for uniform refinement

221:   Input Parameter:
222: . dm - The `DM`

224:   Output Parameter:
225: . refinementUniform - The flag for uniform refinement

227:   Level: developer

229: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMRefine()`, `DMPlexSetRefinementUniform()`, `DMPlexGetRefinementLimit()`, `DMPlexSetRefinementLimit()`
230: @*/
231: PetscErrorCode DMPlexGetRefinementUniform(DM dm, PetscBool *refinementUniform)
232: {
233:   DM_Plex *mesh = (DM_Plex *)dm->data;

235:   PetscFunctionBegin;
237:   PetscAssertPointer(refinementUniform, 2);
238:   *refinementUniform = mesh->refinementUniform;
239:   PetscFunctionReturn(PETSC_SUCCESS);
240: }

242: /*@
243:   DMPlexSetRefinementLimit - Set the maximum cell volume for refinement

245:   Input Parameters:
246: + dm              - The `DM`
247: - refinementLimit - The maximum cell volume in the refined mesh

249:   Level: developer

251: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMRefine()`, `DMPlexGetRefinementLimit()`, `DMPlexGetRefinementUniform()`, `DMPlexSetRefinementUniform()`
252: @*/
253: PetscErrorCode DMPlexSetRefinementLimit(DM dm, PetscReal refinementLimit)
254: {
255:   DM_Plex *mesh = (DM_Plex *)dm->data;

257:   PetscFunctionBegin;
259:   mesh->refinementLimit = refinementLimit;
260:   PetscFunctionReturn(PETSC_SUCCESS);
261: }

263: /*@
264:   DMPlexGetRefinementLimit - Retrieve the maximum cell volume for refinement

266:   Input Parameter:
267: . dm - The `DM`

269:   Output Parameter:
270: . refinementLimit - The maximum cell volume in the refined mesh

272:   Level: developer

274: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMRefine()`, `DMPlexSetRefinementLimit()`, `DMPlexGetRefinementUniform()`, `DMPlexSetRefinementUniform()`
275: @*/
276: PetscErrorCode DMPlexGetRefinementLimit(DM dm, PetscReal *refinementLimit)
277: {
278:   DM_Plex *mesh = (DM_Plex *)dm->data;

280:   PetscFunctionBegin;
282:   PetscAssertPointer(refinementLimit, 2);
283:   /* if (mesh->refinementLimit < 0) = getMaxVolume()/2.0; */
284:   *refinementLimit = mesh->refinementLimit;
285:   PetscFunctionReturn(PETSC_SUCCESS);
286: }

288: /*@C
289:   DMPlexSetRefinementFunction - Set the function giving the maximum cell volume for refinement

291:   Input Parameters:
292: + dm             - The `DM`
293: - refinementFunc - Function giving the maximum cell volume in the refined mesh

295:   Calling Sequence of `refinementFunc`:
296: + coords - Coordinates of the current point, usually a cell centroid
297: - limit  - The maximum cell volume for a cell containing this point

299:   Level: developer

301: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMRefine()`, `DMPlexGetRefinementFunction()`, `DMPlexGetRefinementUniform()`, `DMPlexSetRefinementUniform()`, `DMPlexGetRefinementLimit()`, `DMPlexSetRefinementLimit()`
302: @*/
303: PetscErrorCode DMPlexSetRefinementFunction(DM dm, PetscErrorCode (*refinementFunc)(const PetscReal coords[], PetscReal *limit))
304: {
305:   DM_Plex *mesh = (DM_Plex *)dm->data;

307:   PetscFunctionBegin;
309:   mesh->refinementFunc = refinementFunc;
310:   PetscFunctionReturn(PETSC_SUCCESS);
311: }

313: /*@C
314:   DMPlexGetRefinementFunction - Get the function giving the maximum cell volume for refinement

316:   Input Parameter:
317: . dm - The `DM`

319:   Output Parameter:
320: . refinementFunc - Function giving the maximum cell volume in the refined mesh

322:   Calling Sequence of `refinementFunc`:
323: + coords - Coordinates of the current point, usually a cell centroid
324: - limit  - The maximum cell volume for a cell containing this point

326:   Level: developer

328: .seealso: [](ch_unstructured), `DM`, `DMPLEX`, `DMRefine()`, `DMPlexSetRefinementFunction()`, `DMPlexGetRefinementUniform()`, `DMPlexSetRefinementUniform()`, `DMPlexGetRefinementLimit()`, `DMPlexSetRefinementLimit()`
329: @*/
330: PetscErrorCode DMPlexGetRefinementFunction(DM dm, PetscErrorCode (**refinementFunc)(const PetscReal coords[], PetscReal *limit))
331: {
332:   DM_Plex *mesh = (DM_Plex *)dm->data;

334:   PetscFunctionBegin;
336:   PetscAssertPointer(refinementFunc, 2);
337:   *refinementFunc = mesh->refinementFunc;
338:   PetscFunctionReturn(PETSC_SUCCESS);
339: }

341: PetscErrorCode DMRefine_Plex(DM dm, MPI_Comm comm, DM *rdm)
342: {
343:   PetscBool isUniform;

345:   PetscFunctionBegin;
346:   PetscCall(DMPlexGetRefinementUniform(dm, &isUniform));
347:   PetscCall(DMViewFromOptions(dm, NULL, "-initref_dm_view"));
348:   if (isUniform) {
349:     DMPlexTransform     tr;
350:     DM                  cdm, rcdm;
351:     DMPlexTransformType trType;
352:     const char         *prefix;
353:     PetscOptions        options;
354:     PetscInt            cDegree;
355:     PetscBool           useCeed;

357:     PetscCall(DMPlexTransformCreate(PetscObjectComm((PetscObject)dm), &tr));
358:     PetscCall(DMPlexTransformSetDM(tr, dm));
359:     PetscCall(DMPlexGetTransformType(dm, &trType));
360:     if (trType) PetscCall(DMPlexTransformSetType(tr, trType));
361:     PetscCall(PetscObjectGetOptionsPrefix((PetscObject)dm, &prefix));
362:     PetscCall(PetscObjectSetOptionsPrefix((PetscObject)tr, prefix));
363:     PetscCall(PetscObjectGetOptions((PetscObject)dm, &options));
364:     PetscCall(PetscObjectSetOptions((PetscObject)tr, options));
365:     PetscCall(DMPlexTransformSetFromOptions(tr));
366:     PetscCall(PetscObjectSetOptions((PetscObject)tr, NULL));
367:     PetscCall(DMPlexTransformSetUp(tr));
368:     PetscCall(PetscObjectViewFromOptions((PetscObject)tr, NULL, "-dm_plex_transform_view"));
369:     PetscCall(DMPlexTransformApply(tr, dm, rdm));
370:     PetscCall(DMPlexSetRegularRefinement(*rdm, PETSC_TRUE));
371:     PetscCall(DMPlexGetUseCeed(dm, &useCeed));
372:     PetscCall(DMPlexSetUseCeed(*rdm, useCeed));
373:     PetscCall(DMSetMatType(*rdm, dm->mattype));
374:     PetscCall(DMCopyDisc(dm, *rdm));
375:     PetscCall(DMGetCoordinateDM(dm, &cdm));
376:     PetscCall(DMGetCoordinateDM(*rdm, &rcdm));
377:     PetscCall(DMGetCoordinateDegree_Internal(dm, &cDegree));
378:     {
379:       PetscDS cds, rcds;

381:       PetscCall(DMPlexCreateCoordinateSpace(*rdm, cDegree, PETSC_TRUE, NULL));
382:       PetscCall(DMGetCoordinateDM(*rdm, &rcdm));
383:       PetscCall(DMGetDS(cdm, &cds));
384:       PetscCall(DMGetDS(rcdm, &rcds));
385:       PetscCall(PetscDSCopyConstants(cds, rcds));
386:     }
387:     PetscCall(DMPlexGetUseCeed(cdm, &useCeed));
388:     PetscCall(DMPlexSetUseCeed(rcdm, useCeed));
389:     if (useCeed) {
390:       PetscCall(DMPlexSetUseMatClosurePermutation(rcdm, PETSC_FALSE));
391:       PetscCall(DMUseTensorOrder(rcdm, PETSC_TRUE));
392:     }
393:     PetscCall(DMPlexTransformCreateDiscLabels(tr, *rdm));
394:     PetscCall(DMPlexTransformDestroy(&tr));
395:   } else {
396:     PetscCall(DMPlexRefine_Internal(dm, NULL, NULL, NULL, rdm));
397:   }
398:   if (*rdm) {
399:     ((DM_Plex *)(*rdm)->data)->printFEM = ((DM_Plex *)dm->data)->printFEM;
400:     ((DM_Plex *)(*rdm)->data)->printL2  = ((DM_Plex *)dm->data)->printL2;
401:   }
402:   PetscCall(DMViewFromOptions(*rdm, NULL, "-postref_dm_view"));
403:   PetscFunctionReturn(PETSC_SUCCESS);
404: }

406: PetscErrorCode DMRefineHierarchy_Plex(DM dm, PetscInt nlevels, DM rdm[])
407: {
408:   DM        cdm = dm;
409:   PetscInt  r;
410:   PetscBool isUniform, localized, useCeed;

412:   PetscFunctionBegin;
413:   PetscCall(DMPlexGetRefinementUniform(dm, &isUniform));
414:   PetscCall(DMGetCoordinatesLocalized(dm, &localized));
415:   if (isUniform) {
416:     for (r = 0; r < nlevels; ++r) {
417:       DMPlexTransform tr;
418:       DM              codm, rcodm;
419:       const char     *prefix;

421:       PetscCall(DMPlexTransformCreate(PetscObjectComm((PetscObject)cdm), &tr));
422:       PetscCall(PetscObjectGetOptionsPrefix((PetscObject)cdm, &prefix));
423:       PetscCall(PetscObjectSetOptionsPrefix((PetscObject)tr, prefix));
424:       PetscCall(DMPlexTransformSetDM(tr, cdm));
425:       PetscCall(DMPlexTransformSetFromOptions(tr));
426:       PetscCall(DMPlexTransformSetUp(tr));
427:       PetscCall(DMPlexTransformApply(tr, cdm, &rdm[r]));
428:       PetscCall(DMSetCoarsenLevel(rdm[r], cdm->leveldown));
429:       PetscCall(DMSetRefineLevel(rdm[r], cdm->levelup + 1));
430:       PetscCall(DMSetMatType(rdm[r], dm->mattype));
431:       PetscCall(DMPlexGetUseCeed(dm, &useCeed));
432:       PetscCall(DMPlexSetUseCeed(rdm[r], useCeed));
433:       PetscCall(DMCopyDisc(cdm, rdm[r]));
434:       PetscCall(DMGetCoordinateDM(dm, &codm));
435:       PetscCall(DMGetCoordinateDM(rdm[r], &rcodm));
436:       PetscCall(DMCopyDisc(codm, rcodm));
437:       PetscCall(DMPlexGetUseCeed(codm, &useCeed));
438:       PetscCall(DMPlexSetUseCeed(rcodm, useCeed));
439:       if (useCeed) {
440:         PetscCall(DMPlexSetUseMatClosurePermutation(rcodm, PETSC_FALSE));
441:         PetscCall(DMUseTensorOrder(rcodm, PETSC_TRUE));
442:       }
443:       PetscCall(DMPlexTransformCreateDiscLabels(tr, rdm[r]));
444:       PetscCall(DMSetCoarseDM(rdm[r], cdm));
445:       PetscCall(DMPlexSetRegularRefinement(rdm[r], PETSC_TRUE));
446:       if (rdm[r]) {
447:         ((DM_Plex *)rdm[r]->data)->printFEM = ((DM_Plex *)dm->data)->printFEM;
448:         ((DM_Plex *)rdm[r]->data)->printL2  = ((DM_Plex *)dm->data)->printL2;
449:       }
450:       cdm = rdm[r];
451:       PetscCall(DMPlexTransformDestroy(&tr));
452:     }
453:   } else {
454:     for (r = 0; r < nlevels; ++r) {
455:       PetscCall(DMRefine(cdm, PetscObjectComm((PetscObject)dm), &rdm[r]));
456:       PetscCall(DMPlexGetUseCeed(dm, &useCeed));
457:       PetscCall(DMPlexSetUseCeed(rdm[r], useCeed));
458:       PetscCall(DMCopyDisc(cdm, rdm[r]));
459:       if (localized) PetscCall(DMLocalizeCoordinates(rdm[r]));
460:       PetscCall(DMSetCoarseDM(rdm[r], cdm));
461:       if (rdm[r]) {
462:         ((DM_Plex *)rdm[r]->data)->printFEM = ((DM_Plex *)dm->data)->printFEM;
463:         ((DM_Plex *)rdm[r]->data)->printL2  = ((DM_Plex *)dm->data)->printL2;
464:       }
465:       cdm = rdm[r];
466:     }
467:   }
468:   PetscFunctionReturn(PETSC_SUCCESS);
469: }