Package petsc4py :: Module PETSc :: Class DMPlex
[hide private]
[frames] | no frames]

Class DMPlex


Nested Classes [hide private]
  ReorderDefaultFlag

Inherited from DM: BoundaryType, PolytopeType, Type

Instance Methods [hide private]
a new object with type S, a subtype of T
__new__(S, ...)
 
computeCellGeometryFVM(self, cell)
 
computeGradientClementInterpolant(self, Vec locX, Vec locC)
 
constructGhostCells(self, labelName=None)
 
coordinatesLoad(self, Viewer viewer, SF sfxc)
 
coordinatesView(self, Viewer viewer)
 
create(self, comm=None)
 
createBoxMesh(self, faces, lower=(0, 0, 0), upper=(1, 1, 1), simplex=True, periodic=False, interpolate=True, comm=None)
 
createBoxSurfaceMesh(self, faces, lower=(0, 0, 0), upper=(1, 1, 1), interpolate=True, comm=None)
 
createCGNS(self, cgid, interpolate=True, comm=None)
 
createCGNSFromFile(self, filename, interpolate=True, comm=None)
 
createClosureIndex(self, Section sec)
 
createCoarsePointIS(self)
 
createCohesiveSubmesh(self, hasLagrange, value)
 
createExodus(self, exoid, interpolate=True, comm=None)
 
createExodusFromFile(self, filename, interpolate=True, comm=None)
 
createFromCellList(self, dim, cells, coords, interpolate=True, comm=None)
 
createFromFile(self, filename, plexname='unnamed', interpolate=True, comm=None)
 
createGmsh(self, Viewer viewer, interpolate=True, comm=None)
 
createPointNumbering(self)
 
createSection(self, numComp, numDof, bcField=None, bcComps=None, bcPoints=None, IS perm=None)
 
distribute(self, overlap=0)
 
distributeField(self, SF sf, Section sec, Vec vec, Section newsec=None, Vec newvec=None)
 
distributeGetDefault(self)
 
distributeOverlap(self, overlap=0)
 
distributeSetDefault(self, flag)
 
distributionGetName(self)
 
distributionSetName(self, name)
 
generate(self, DMPlex boundary, name=None, interpolate=True)
 
getAdjacency(self, p)
 
getAdjacencyUseAnchors(self)
 
getCellNumbering(self)
 
getCellType(self, p)
 
getCellTypeLabel(self)
 
getChart(self)
 
getCone(self, p)
 
getConeOrientation(self, p)
 
getConeSize(self, p)
 
getDepth(self)
 
getDepthStratum(self, svalue)
 
getFullJoin(self, points)
 
getHeightStratum(self, svalue)
 
getJoin(self, points)
 
getMaxSizes(self)
 
getMeet(self, points)
 
getMinRadius(self)
 
getOrdering(self, otype)
 
getPartitioner(self)
 
getPointDepth(self, point)
 
getPointGlobal(self, point)
 
getPointGlobalField(self, point, field)
 
getPointHeight(self, point)
 
getPointLocal(self, point)
 
getPointLocalField(self, point, field)
 
getRefinementLimit(self)
 
getRefinementUniform(self)
 
getSupport(self, p)
 
getSupportSize(self, p)
 
getTransitiveClosure(self, p, useCone=True)
 
getVecClosure(self, Section sec, Vec vec, point)
 
getVertexNumbering(self)
 
globalVectorLoad(self, Viewer viewer, DM sectiondm, SF sf, Vec vec)
 
globalVectorView(self, Viewer viewer, DM sectiondm, Vec vec)
 
insertCone(self, p, conePos, conePoint)
 
insertConeOrientation(self, p, conePos, coneOrientation)
 
interpolate(self)
 
isDistributed(self)
 
isSimplex(self)
 
labelCohesiveComplete(self, DMLabel label, DMLabel bdlabel, bdvalue, flip, DMPlex subdm)
 
labelComplete(self, DMLabel label)
 
labelsLoad(self, Viewer viewer, SF sfxc)
 
labelsView(self, Viewer viewer)
 
localVectorLoad(self, Viewer viewer, DM sectiondm, SF sf, Vec vec)
 
localVectorView(self, Viewer viewer, DM sectiondm, Vec vec)
 
markBoundaryFaces(self, label, value=None)
 
metricAverage2(self, Vec metric1, Vec metric2, Vec metricAvg)
 
metricAverage3(self, Vec metric1, Vec metric2, Vec metric3, Vec metricAvg)
 
metricCreate(self, field=0)
 
metricCreateIsotropic(self, Vec indicator, field=0)
 
metricCreateUniform(self, PetscReal alpha, field=0)
 
metricDeterminantCreate(self, field=0)
 
metricEnforceSPD(self, Vec metric, Vec ometric, Vec determinant, restrictSizes=False, restrictAnisotropy=False)
 
metricGetGradationFactor(self)
 
metricGetHausdorffNumber(self)
 
metricGetMaximumAnisotropy(self)
 
metricGetMaximumMagnitude(self)
 
metricGetMinimumMagnitude(self)
 
metricGetNormalizationOrder(self)
 
metricGetNumIterations(self)
 
metricGetTargetComplexity(self)
 
metricGetVerbosity(self)
 
metricIntersection2(self, Vec metric1, Vec metric2, Vec metricInt)
 
metricIntersection3(self, Vec metric1, Vec metric2, Vec metric3, Vec metricInt)
 
metricIsIsotropic(self)
 
metricIsUniform(self)
 
metricNoInsertion(self)
 
metricNoMovement(self)
 
metricNoSurf(self)
 
metricNoSwapping(self)
 
metricNormalize(self, Vec metric, Vec ometric, Vec determinant, restrictSizes=True, restrictAnisotropy=True)
 
metricRestrictAnisotropyFirst(self)
 
metricSetFromOptions(self)
 
metricSetGradationFactor(self, PetscReal beta)
 
metricSetHausdorffNumber(self, PetscReal hausd)
 
metricSetIsotropic(self, PetscBool isotropic)
 
metricSetMaximumAnisotropy(self, PetscReal a_max)
 
metricSetMaximumMagnitude(self, PetscReal h_max)
 
metricSetMinimumMagnitude(self, PetscReal h_min)
 
metricSetNoInsertion(self, PetscBool noInsert)
 
metricSetNoMovement(self, PetscBool noMove)
 
metricSetNoSurf(self, PetscBool noSurf)
 
metricSetNoSwapping(self, PetscBool noSwap)
 
metricSetNormalizationOrder(self, PetscReal p)
 
metricSetNumIterations(self, PetscInt numIter)
 
metricSetRestrictAnisotropyFirst(self, PetscBool restrictAnisotropyFirst)
 
metricSetTargetComplexity(self, PetscReal targetComplexity)
 
metricSetUniform(self, PetscBool uniform)
 
metricSetVerbosity(self, PetscInt verbosity)
 
orient(self)
 
permute(self, IS perm)
 
rebalanceSharedPoints(self, entityDepth=0, useInitialGuess=True, parallel=True)
 
reorderGetDefault(self)
 
reorderSetDefault(self, flag)
 
sectionLoad(self, Viewer viewer, DM sectiondm, SF sfxc)
 
sectionView(self, Viewer viewer, DM sectiondm)
 
setAdjacencyUseAnchors(self, useAnchors=True)
 
setCellType(self, p, ctype)
 
setChart(self, pStart, pEnd)
 
setCone(self, p, cone, orientation=None)
 
setConeOrientation(self, p, orientation)
 
setConeSize(self, p, size)
 
setMatClosure(self, Section sec, Section gsec, Mat mat, point, values, addv=None)
 
setPartitioner(self, Partitioner part)
 
setRefinementLimit(self, refinementLimit)
 
setRefinementUniform(self, refinementUniform=True)
 
setSupport(self, p, supp)
 
setSupportSize(self, p, size)
 
setTetGenOptions(self, opts)
 
setTriangleOptions(self, opts)
 
setVecClosure(self, Section sec, Vec vec, point, values, addv=None)
 
stratify(self)
 
symmetrize(self)
 
topologyLoad(self, Viewer viewer)
 
topologyView(self, Viewer viewer)
 
uninterpolate(self)
 
vecGetClosure(self, Section sec, Vec vec, p)

Inherited from DM: adaptLabel, adaptMetric, addCoarsenHook, addField, appendOptionsPrefix, clearDS, clearFields, clearLabelStratum, clearLabelValue, clone, coarsen, coarsenHierarchy, convert, copyDS, copyDisc, copyFields, createDS, createDefaultSF, createFieldDecomposition, createGlobalVec, createGlobalVector, createInjection, createInterpolation, createLabel, createLocalVec, createLocalVector, createMassMatrix, createMat, createMatrix, createRestriction, createSectionSF, createSubDM, destroy, getAppCtx, getAuxiliaryVec, getBasicAdjacency, getBlockSize, getBoundingBox, getCoarsenLevel, getCoordinateDM, getCoordinateDim, getCoordinateSection, getCoordinates, getCoordinatesLocal, getDS, getDefaultGlobalSection, getDefaultLocalSection, getDefaultSF, getDefaultSection, getDimension, getField, getFieldAdjacency, getGlobalSection, getGlobalVec, getLGMap, getLabel, getLabelIdIS, getLabelName, getLabelOutput, getLabelSize, getLabelValue, getLocalBoundingBox, getLocalSection, getLocalVec, getMatrix, getNumFields, getNumLabels, getOptionsPrefix, getPointSF, getRefineLevel, getSection, getSectionSF, getStratumIS, getStratumSize, getType, globalToLocal, hasLabel, load, localToGlobal, localToLocal, localizeCoordinates, projectCoordinates, refine, refineHierarchy, removeLabel, restoreGlobalVec, restoreLocalVec, setAppCtx, setAuxiliaryVec, setBasicAdjacency, setCoordinateDim, setCoordinates, setCoordinatesLocal, setDefaultGlobalSection, setDefaultLocalSection, setDefaultSF, setDefaultSection, setDimension, setField, setFieldAdjacency, setFromOptions, setGlobalSection, setKSPComputeOperators, setLabelOutput, setLabelValue, setLocalSection, setMatType, setNumFields, setOptionsPrefix, setPointSF, setRefineLevel, setSNESFunction, setSNESJacobian, setSection, setSectionSF, setType, setUp, setVecType, view, viewFromOptions

Inherited from Object: __copy__, __deepcopy__, __eq__, __ge__, __gt__, __le__, __lt__, __ne__, __nonzero__, compose, decRef, getAttr, getClassId, getClassName, getComm, getDict, getName, getRefCount, getTabLevel, incRef, incrementTabLevel, query, setAttr, setName, setTabLevel, stateGet, stateIncrease, stateSet

Inherited from object: __delattr__, __format__, __getattribute__, __hash__, __init__, __reduce__, __reduce_ex__, __repr__, __setattr__, __sizeof__, __str__, __subclasshook__

Properties [hide private]

Inherited from DM: appctx, ds

Inherited from Object: classid, comm, fortran, handle, klass, name, prefix, refcount, type

Inherited from object: __class__

Method Details [hide private]

__new__(S, ...)

 
Returns: a new object with type S, a subtype of T
Overrides: object.__new__

create(self, comm=None)

 
Overrides: DM.create