petsc-3.6.1 2015-08-06
Report Typos and Errors

DM Examples

DM objects are used to manage communication between the algebraic structures in PETSc (Vec and Mat) and mesh data structures in PDE-based (or other) simulations. See, for example, DMDACreate().

Beginner - Basic usage
DMBoundaryType DMMoabGetVecTag DMPlexSetCone
DMClone DMMoabGetVertexConnectivity DMPlexSetConeOrientation
DMCompositeGetNumberDM DMMoabGetVertexCoordinates DMPlexSetConeSize
DMCreateGlobalVector DMMoabIsEntityOnBoundary DMPlexSetLabelValue
DMCreate DMMoabLoadFromFile DMPlexSetSupport
DMCreateLocalVector DMMoabRestoreVertexConnectivity DMPlexSetSupportSize
DMCreateMatrix DMMoabSetBlockSize DMPlexStratify
DMDACreate1d DMMoabSetInterface DMPlexSymmetrize
DMDACreate2d DMMoabSetLocalElements DMRestoreGlobalVector
DMDACreate3d DMMoabSetLocalToGlobalTag DMRestoreLocalVector
DMDAElementType DMMoabSetLocalVertices DMSetDimension
DMDAGetBoundingBox DMMoabSetParallelComm DMType
DMDAGetCorners DMNetworkCreate DMView
DMDAGetGhostCorners DMPatchCreate PetscDSAddBdDiscretization
DMDAGetInfo DMPlexAddConeSize PetscDSAddDiscretization
DMDAGetLocalBoundingBox DMPlexClearLabelStratum PetscDSCreate
DMDAGetLocalInfo DMPlexClearLabelValue PetscDSGetBdDiscretization
DMDAInterpolationType DMPlexCreateBoxMesh PetscDSGetBdFieldOffset
DMDALocalInfo DMPlexCreateCGNS PetscDSGetComponentBdDerivativeOffsets
DMDASetUniformCoordinates DMPlexCreateCubeBoundary PetscDSGetComponentBdOffsets
DMDA_STENCIL_BOX DMPlexCreateDoublet PetscDSGetComponentDerivativeOffsets
DMDA_STENCIL_STAR DMPlexCreateExodus PetscDSGetComponentOffset
DMDAStencilType DMPlexCreateFluentFromFile PetscDSGetComponentOffsets
DMGetDimension DMPlexCreateFluent PetscDSGetDiscretization
DMGetGlobalVector DMPlexCreateFromCellList PetscDSGetFieldOffset
DMGetLocalVector DMPlexCreateFromFile PetscDSGetNumFields
DMGlobalToLocalBegin DMPlexCreateGmshFromFile PetscDSGetSpatialDimension
DMGlobalToLocalEnd DMPlexCreateGmsh PetscDSGetTotalBdDimension
DMLocalToGlobalBegin DMPlexCreateHexBoxMesh PetscDSGetTotalComponents
DMLocalToGlobalEnd DMPlexCreate PetscDSGetTotalDimension
DMMoabCreateBoxMesh DMPlexCreateSquareBoundary PetscDSSetBdDiscretization
DMMoabCreateVector DMPlexCreateSquareMesh PetscDSSetDiscretization
DMMoabGetAllVertices DMPlexGetChart PetscDualSpaceCreate
DMMoabGetBlockSize DMPlexGetCone PetscDualSpaceDuplicate
DMMoabGetBoundaryMarkers DMPlexGetConeOrientation PetscFECreateDefault
DMMoabGetDimension DMPlexGetConeSize PetscFECreate
DMMoabGetElementConnectivity DMPlexGetLabelIdIS PetscFVCreate
DMMoabGetFieldDof DMPlexGetLabelSize PetscLimiterCreate
DMMoabGetInterface DMPlexGetLabelValue PetscPartitionerCreate
DMMoabGetLocalElements DMPlexGetMaxSizes PetscQuadratureCreate
DMMoabGetLocalSize DMPlexGetStratumIS PetscQuadratureDestroy
DMMoabGetLocalToGlobalTag DMPlexGetStratumSize PetscQuadratureDuplicate
DMMoabGetLocalVertices DMPlexGetSupport PetscQuadratureView
DMMoabGetMaterialBlock DMPlexGetSupportSize PetscSpaceCreate
DMMoabGetOffset DMPlexGetTransitiveClosure PetscSpacePolynomialGetTensor
DMMoabGetParallelComm DMPlexGetTransitiveClosure_Internal PetscSpacePolynomialSetTensor
DMMoabGetSize DMPlexRestoreTransitiveClosure
DMMoabGetVecRange DMPlexSetChart
Intermediate - Setting options for algorithms and data structures
DMCompositeGetLocalISs DMMoabSetFieldVector DMSetType
DMCOMPOSITE DMMoabSetGlobalFieldVector DMSetVariableBounds
DMConvert DMMoabVecGetArray DMSetVecType
DMCreateAggregates DMMoabVecGetArrayRead DMSLICED
DMCreateDefaultSF DMMoabVecRestoreArray MatCreateSeqUSFFT
DMCreateDomainDecomposition DMNetworkAddComponent MatGetDM
DMCreateFieldDecomposition DMNetworkAddNumVariables MATHYPRESSTRUCT
DMCreateFieldIS DMNetworkDistribute MATHYPRESTRUCT
DMCreateSubDM DMNetworkGetComponentDataArray MatSetDM
DMDACoor2d DMNetworkGetComponentTypeOffset MatSetupDM
DMDACoor3d DMNetworkGetConnectedNodes PETSCDSBASIC
DMDAGetAO DMNetworkGetEdgeRange PetscDSGetBdJacobian
DMDAGetCoordinateArray DMNetworkGetNumComponents PetscDSGetBdResidual
DMDAGetCoordinateName DMNetworkGetSupportingEdges PetscDSGetBdTabulation
DMDAGetElements DMNetworkGetVariableGlobalOffset PetscDSGetJacobian
DMDAGetElementType DMNetworkGetVariableOffset PetscDSGetResidual
DMDAGetFieldName DMNetworkGetVertexRange PetscDSGetRiemannSolver
DMDAGetFieldNames DMNETWORK PetscDSGetTabulation
DMDAGetInterpolationType DMNetworkIsGhostVertex PetscDSGetType
DMDAGetNeighbors DMNetworkLayoutSetUp PetscDSSetBdJacobian
DMDAGetNonOverlappingRegion DMNetworkRegisterComponent PetscDSSetBdResidual
DMDAGetNumLocalSubDomains DMNetworkSetEdgeList PetscDSSetJacobian
DMDAGetOffset DMNetworkSetNumVariables PetscDSSetResidual
DMDAGetOverlap DMNetworkSetSizes PetscDSSetRiemannSolver
DMDAGetOwnershipRanges DMOutputSequenceLoad PetscDSSetType
DMDAGetReducedDMDA DMPlexCopyCoordinates PetscDTGaussJacobiQuadrature
DMDAGetRefinementFactor DMPlexCopyLabels PetscDTGaussQuadrature
DMDA DMPlexCreateClosureIndex PetscDTGaussTensorQuadrature
DMDANaturalToGlobalEnd DMPlexCreateDefaultReferenceTree PetscDTLegendreEval
DMDARestoreCoordinateArray DMPlexCreateLabel PetscDualSpaceGetDimension
DMDARestoreElements DMPlexCreateReferenceCell PetscDualSpaceGetDM
DMDASetAOType DMPlexDistribute PetscDualSpaceGetFunctional
DMDASetBoundaryType DMPlexEqual PetscDualSpaceGetNumDof
DMDASetCoordinateName DMPlexGenerate PetscDualSpaceGetOrder
DMDASetDof DMPlexGetAdjacencyUseAnchors PetscDualSpaceGetType
DMDASetElementType DMPlexGetAdjacencyUseClosure PetscDualSpaceLagrangeGetContinuity
DMDASetFieldName DMPlexGetAdjacencyUseCone PETSCDUALSPACELAGRANGE
DMDASetFieldNames DMPlexGetAnchors PetscDualSpaceLagrangeSetContinuity
DMDASetInterpolationType DMPlexGetCoarseDM PetscDualSpaceSetDM
DMDASetNonOverlappingRegion DMPlexGetFullJoin PetscDualSpaceSetOrder
DMDASetNumLocalSubDomains DMPlexGetFullMeet PetscDualSpaceSetType
DMDASetNumProcs DMPlexGetJoin PETSCDUALSPACESIMPLE
DMDASetOffset DMPlexGetLabelByNum PetscDualSpaceSimpleSetDimension
DMDASetOverlap DMPlexGetLabel PetscDualSpaceSimpleSetFunctional
DMDASetOwnershipRanges DMPlexGetLabelName PETSCFEBASIC
DMDASetRefinementFactor DMPlexGetMaxProjectionHeight PetscFECompositeGetMapping
DMDASetSizes DMPlexGetMeet PETSCFECOMPOSITE
DMDASetStencilType DMPlexGetNumBoundary PetscFEGetBasisSpace
DMDASetStencilWidth DMPlexGetNumLabels PetscFEGetDimension
DMDAVecGetArrayDOF DMPlexGetOrdering PetscFEGetDualSpace
DMDAVecGetArrayDOFRead DMPlexGetPointGlobalField PetscFEGetNumComponents
DMDAVecGetArray DMPlexGetPointGlobal PetscFEGetQuadrature
DMDAVecGetArrayRead DMPlexGetPointLocalField PetscFEGetSpatialDimension
DMDAVecRestoreArrayDOF DMPlexGetPointLocal PetscFEGetTileSizes
DMDAVecRestoreArrayDOFRead DMPlexGetReferenceTree PetscFEGetType
DMDAVecRestoreArray DMPlexGetTreeChildren PETSCFENONAFFINE
DMDAVecRestoreArrayRead DMPlexGetTree PETSCFEOPENCL
DMGetApplicationContext DMPlexGetTreeParent PetscFESetBasisSpace
DMGetBlockSize DMPlexHasLabel PetscFESetDualSpace
DMGetCoordinateDim DMPLEX PetscFESetNumComponents
DMGetCoordinateDM DMPlexInterpolate PetscFESetQuadrature
DMGetCoordinateSection DMPlexMatSetClosure PetscFESetTileSizes
DMGetCoordinates DMPlexMigrate PetscFESetType
DMGetCoordinatesLocal DMPlexPermute PetscFVGetType
DMGetDefaultGlobalSection DMPlexPointGlobalFieldRead PETSCFVLEASTSQUARES
DMGetDefaultSection DMPlexPointGlobalFieldRef PetscFVLeastSquaresSetMaxFaces
DMGetDefaultSF DMPlexPointGlobalRead PetscFVSetDualSpace
DMGetDimPoints DMPlexPointGlobalRef PetscFVSetType
DMGetLocalToGlobalMapping DMPlexPointLocalFieldRead PETSCFVUPWIND
DMGetMatType DMPlexPointLocalFieldRef PetscLimiterGetType
DMGetOutputDM DMPlexPointLocalRead PETSCLIMITERMC
DMGetOutputSequenceNumber DMPlexPointLocalRef PETSCLIMITERMINMOD
DMGetPointSF DMPlexRestoreJoin PETSCLIMITERNONE
DMGetType DMPlexRestoreMeet PetscLimiterSetType
DMGetVecType DMPlexSetAdjacencyUseAnchors PETSCLIMITERSIN
DM DMPlexSetAdjacencyUseClosure PETSCLIMITERSUPERBEE
DMLabelClearValue DMPlexSetAdjacencyUseCone PETSCLIMITERVANALBADA
DMLabelGetValue DMPlexSetAnchors PETSCLIMITERVANLEER
DMLabelInsertIS DMPlexSetCoarseDM PETSCLIMITERZERO
DMLabelSetValue DMPlexSetReferenceTree PETSCPARTITIONERCHACO
DMLabelStratumHasPoint DMPlexSetTree PetscPartitionerGetType
DMLabelView DMPlexUninterpolate PetscPartitioner
DMLoad DMPlexVecGetClosure PETSCPARTITIONERPARMETIS
DMLocalToLocalBegin DMPlexVecRestoreClosure PetscPartitionerSetType
DMLocalToLocalEnd DMPlexVecSetClosure PETSCPARTITIONERSHELL
DMMoabCreate DMREDUNDANT PETSCPARTITIONERSIMPLE
DMMoabGetDofsBlocked DMSetApplicationContextDestroy PetscQuadratureExpandComposite
DMMoabGetDofsBlockedLocal DMSetApplicationContext PetscQuadratureGetData
DMMoabGetDofs DMSetCoordinateDim PetscQuadratureGetOrder
DMMoabGetDofsLocal DMSetCoordinateDM PetscQuadratureSetData
DMMoabGetFieldDofs DMSetCoordinateSection PetscQuadratureSetOrder
DMMoabGetFieldDofsLocal DMSetCoordinates PETSCSPACEDG
DMMoabGetFieldName DMSetCoordinatesLocal PetscSpaceGetOrder
DMMoabGetVertexDofsBlocked DMSetDefaultGlobalSection PetscSpaceGetType
DMMoabGetVertexDofsBlockedLocal DMSetDefaultSection PETSCSPACEPOLYNOMIAL
DMMOAB DMSetDefaultSF PetscSpaceSetOrder
DMMoabOutput DMSetMatType PetscSpaceSetType
DMMoabSetFieldName DMSetOutputSequenceNumber VecGetDM
DMMoabSetFieldNames DMSetPointSF VecSetDM
Advanced - Setting more advanced options and customization
DMCoarsenHookAdd DMGlobalToLocalBeginDefaultShell DMShellSetGlobalToLocal
DMCompositeAddDM DMGlobalToLocalEndDefaultShell DMShellSetGlobalToLocalVecScatter
DMCompositeCreate DMGlobalToLocalHookAdd DMShellSetGlobalVector
DMCompositeGatherArray DMLocalToGlobalBeginDefaultShell DMShellSetLocalToGlobal
DMCompositeGather DMLocalToGlobalEndDefaultShell DMShellSetLocalToGlobalVecScatter
DMCompositeGetAccessArray DMLocalToGlobalHookAdd DMShellSetLocalToLocal
DMCompositeGetAccess DMLocalToLocalBeginDefaultShell DMShellSetLocalToLocalVecScatter
DMCompositeGetEntriesArray DMLocalToLocalEndDefaultShell DMShellSetLocalVector
DMCompositeGetEntries DMPlexComputeCellGeometryAffineFEM DMShellSetMatrix
DMCompositeGetGlobalISs DMPlexComputeCellGeometryFEM DMShellSetRefine
DMCompositeGetISLocalToGlobalMappings DMPlexComputeCellGeometryFVM DMSlicedCreate
DMCompositeGetLocalVectors DMPlexCreateFromDAG DMSlicedSetBlockFills
DMCompositeRestoreAccessArray DMPlexCreateRigidBody DMSlicedSetGhosts
DMCompositeRestoreAccess DMPlexGetAdjacency DMSlicedSetPreallocation
DMCompositeRestoreLocalVectors DMPlexOrient DMSubDomainHookAdd
DMCompositeScatterArray DMPlexReverseCell PetscDSRegisterAll
DMCompositeScatter DMPlexSetMaxProjectionHeight PetscDSRegister
DMCompositeSetCoupling DMRedundantCreate PetscDTReconstructPoly
DMComputeVariableBounds DMRedundantGetSize PetscDualSpaceCreateReferenceCell
DMDACreate DMRedundantSetSize PetscDualSpaceGetHeightSubspace
DMDACreatePF DMRefineHookAdd PetscDualSpaceRegisterAll
DMDAGetArray DMRegisterAll PetscDualSpaceRegister
DMDAGetLogicalCoordinate DMRegister PetscFERegisterAll
DMDAGetProcessorSubset DMSetDefaultConstraints PetscFERegister
DMDAGetProcessorSubsets DMSetOptionsPrefix PetscFVRegisterAll
DMDAGetRay DMShellCreate PetscFVRegister
DMDAGlobalToNaturalAllCreate DMShellSetCoarsen PetscLimiterRegisterAll
DMDAGlobalToNaturalBegin DMShellSetCreateFieldDecomposition PetscLimiterRegister
DMDAGlobalToNaturalEnd DMShellSetCreateGlobalVector PetscPartitionerRegisterAll
DMDANaturalAllToGlobalCreate DMShellSetCreateInjection PetscPartitionerRegister
DMDANaturalToGlobalBegin DMShellSetCreateInterpolation PetscSpaceEvaluate
DMDARestoreArray DMShellSetCreateLocalVector PetscSpaceRegisterAll
DMGetDefaultConstraints DMShellSetCreateMatrix PetscSpaceRegister
Developer - Interfaces intended primarily for library developers, not for typical applications programmers
DMClearGlobalVectors DMPlexCreateSection PetscDSFinalizePackage
DMCoarsenHierarchy DMPlexCreateSubmesh PetscDSGetAdjacency
DMCoarsen DMPlexCreateSubpointIS PetscDSGetImplicit
DMCreateColoring DMPlexCreateTwoSidedProcessSF PetscDSInitializePackage
DMCreateDomainDecompositionScatters DMPlexDerivePointSF PetscDSSetAdjacency
DMCreateInjection DMPlexDistributeData PetscDSSetFromOptions
DMCreateInterpolation DMPlexDistributeField PetscDSSetImplicit
DMCreateInterpolationScale DMPlexDistributeFieldIS PetscDSSetUp
DMDAComputeL2Diff DMPlexDistributeOwnership PetscDSView
DMDAComputeL2GradientDiff DMPlexGetDepth PetscDualSpaceApply
DMDAConvertToCell DMPlexGetDepthLabel PetscDualSpaceDestroy
DMDACreateNaturalVector DMPlexGetDepthStratum PetscDualSpaceSetFromOptions
DMDACreatePatchIS DMPlexGetHeightStratum PetscDualSpaceSetUp
DMDACreateSection DMPlexGetHybridBounds PetscDualSpaceView
DMDAGetCellPoint DMPlexGetLabelOutput PetscFEDestroy
DMDAGetNumCells DMPlexGetMinRadius PetscFEFinalizePackage
DMDAGetPreallocationCenterDimension DMPlexGetPartitioner PetscFEInitializePackage
DMDAGetScatter DMPlexGetRefinementLimit PetscFEIntegrateBdResidual
DMDAProjectFunction DMPlexGetRefinementUniform PetscFEIntegrate
DMDASetBlockFills DMPlexGetSubpointMap PetscFEIntegrateJacobian
DMDASetGetMatrix DMPlexInvertCell PetscFEIntegrateResidual
DMDASetPreallocationCenterDimension DMPlexLabelAddCells PetscFESetFromOptions
DMDAVTKWriteAll DMPlexLabelCohesiveComplete PetscFESetUp
DMDestroy DMPlexLabelComplete PetscFEView
DMFinalizePackage DMPlexLocalizeCoordinate PetscFVComputeGradient
DMGetCoarsenLevel DMPlexLocalizeCoordinates PetscFVDestroy
DMGetDS DMPlexMarkBoundaryFaces PetscFVFinalizePackage
DMGetField DMPlexPartitionLabelAdjacency PetscFVGetComputeGradients
DMGetNamedGlobalVector DMPlexPartitionLabelClosure PetscFVGetDualSpace
DMGetNamedLocalVector DMPlexPartitionLabelCreateSF PetscFVGetLimiter
DMGetRefineLevel DMPlexPartitionLabelInvert PetscFVGetNumComponents
DMGetWorkArray DMPlexProjectFunction PetscFVGetQuadrature
DMHasColoring DMPlexReferenceTreeGetChildSymmetry PetscFVGetSpatialDimension
DMHasVariableBounds DMPlexRemoveLabel PetscFVInitializePackage
DMInitializePackage DMPlexSetHybridBounds PetscFVRefine
DMInterpolate DMPlexSetLabelOutput PetscFVSetComputeGradients
DMLabelHasPoint DMPlexSetMinRadius PetscFVSetFromOptions
DMLabelHasValue DMPlexSetPartitioner PetscFVSetLimiter
DMLocatePoints DMPlexSetRefinementLimit PetscFVSetNumComponents
DMMoabSetBlockFills DMPlexSetRefinementUniform PetscFVSetQuadrature
DMPlexAddBoundary DMPlexStratifyMigrationSF PetscFVSetSpatialDimension
DMPlexAddLabel DMPlexTetgenSetOptions PetscFVSetUp
DMPlexCheckFaces DMPlexTriangleSetOptions PetscFVView
DMPlexCheckSkeleton DMPlexVTKWriteAll PetscLimiterDestroy
DMPlexCheckSymmetry DMRefineHierarchy PetscLimiterSetFromOptions
DMPlexComputeGeometryFVM DMRefine PetscLimiterSetUp
DMPlexComputeGradientFVM DMRestoreNamedGlobalVector PetscLimiterView
DMPlexComputeIntegralFEM DMRestoreNamedLocalVector PetscPartitionerDestroy
DMPlexComputeInterpolatorFEM DMRestoreWorkArray PetscPartitionerPartition
DMPlexComputeL2Diff DMRestrict PetscPartitionerSetFromOptions
DMPlexComputeL2FieldDiff DMSetDS PetscPartitionerSetUp
DMPlexComputeL2GradientDiff DMSetField PetscPartitionerShellSetPartition
DMPlexConstructCohesiveCells DMSetFromOptions PetscPartitionerView
DMPlexConstructGhostCells DMSetMatrixPreallocateOnly PetscQuadrature
DMPlexCreateCoarsePointIS DMSetPeriodicity PetscSectionCreateGlobalSectionLabel
DMPlexCreateHybridMesh DMSetUp PetscSpaceDestroy
DMPlexCreateOverlap DMSetVec PetscSpaceSetFromOptions
DMPlexCreatePartitionerGraph DMSubDomainRestrict PetscSpaceSetUp
DMPlexCreateProcessSF PetscDSDestroy PetscSpaceView
No deprecated routines

Table of Contents