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

Class DMPlex


Nested Classes [hide private]

Inherited from DM: BoundaryType, Type

Instance Methods [hide private]
a new object with type S, a subtype of T
__new__(S, ...)
 
clearLabelStratum(self, name, value)
 
clearLabelValue(self, name, point, value)
 
computeCellGeometryFVM(self, cell)
 
create(self, comm=None)
 
createBoxMesh(self, dim, interpolate=True, comm=None)
 
createCGNS(self, cgid, interpolate=True, comm=None)
 
createCGNSFromFile(self, filename, interpolate=True, comm=None)
 
createCoarsePointIS(self)
 
createCohesiveSubmesh(self, hasLagrange, value)
 
createCubeBoundary(self, lower, upper, faces)
 
createExodus(self, exoid, interpolate=True, comm=None)
 
createExodusFromFile(self, filename, interpolate=True, comm=None)
 
createFromCellList(self, dim, cells, coords, interpolate=True, comm=None)
 
createGmsh(self, Viewer viewer, interpolate=True, comm=None)
 
createHexBoxMesh(self, numcells, boundary_type=None, comm=None)
 
createLabel(self, name)
 
createSection(self, numComp, numDof, bcField=None, bcComps=None, bcPoints=None, IS perm=None)
 
createSquareBoundary(self, lower, upper, edges)
 
distribute(self, overlap=0)
 
distributeOverlap(self, overlap=0)
 
generate(self, DMPlex boundary, name=None, interpolate=True)
 
getCellNumbering(self)
 
getChart(self)
 
getCone(self, p)
 
getConeOrientation(self, p)
 
getConeSize(self, p)
 
getDepth(self)
 
getDepthStratum(self, svalue)
 
getHeightStratum(self, svalue)
 
getJoin(self, points)
 
getLabelIdIS(self, name)
 
getLabelName(self, index)
 
getLabelOutput(self, name)
 
getLabelSize(self, name)
 
getLabelValue(self, name, point)
 
getMaxSizes(self)
 
getMeet(self, points)
 
getNumLabels(self)
 
getOrdering(self, otype)
 
getPartitioner(self)
 
getRefinementLimit(self)
 
getRefinementUniform(self)
 
getStratumIS(self, name, value)
 
getStratumSize(self, name, value)
 
getSupport(self, p)
 
getSupportSize(self, p)
 
getTransitiveClosure(self, p, useCone=True)
 
getVertexNumbering(self)
 
hasLabel(self, name)
 
insertCone(self, p, conePos, conePoint)
 
insertConeOrientation(self, p, conePos, coneOrientation)
 
markBoundaryFaces(self, label)
 
orient(self)
 
permute(self, IS perm)
 
removeLabel(self, name)
 
setAdjacencyUseClosure(self, useClosure=True)
 
setAdjacencyUseCone(self, useCone=True)
 
setChart(self, pStart, pEnd)
 
setCone(self, p, cone, orientation=None)
 
setConeOrientation(self, p, orientation)
 
setConeSize(self, p, size)
 
setLabelOutput(self, name, output)
 
setLabelValue(self, name, point, value)
 
setRefinementLimit(self, refinementLimit)
 
setRefinementUniform(self, refinementUniform=True)
 
setSupport(self, p, supp)
 
setSupportSize(self, p, size)
 
setTetGenOptions(self, opts)
 
setTriangleOptions(self, opts)
 
stratify(self)
 
symmetrize(self)
 
vecGetClosure(self, Section sec, Vec vec, p)

Inherited from DM: clone, coarsen, coarsenHierarchy, convert, createAggregates, createDefaultSF, createGlobalVec, createGlobalVector, createInjection, createInterpolation, createLocalVec, createLocalVector, createMat, createMatrix, destroy, getAppCtx, getBlockSize, getCoordinateDM, getCoordinateSection, getCoordinates, getCoordinatesLocal, getDefaultGlobalSection, getDefaultSF, getDefaultSection, getDimension, getLGMap, getMatrix, getPointSF, getType, globalToLocal, localToGlobal, localToLocal, refine, refineHierarchy, setAppCtx, setCoordinates, setCoordinatesLocal, setDefaultGlobalSection, setDefaultSection, setDimension, setFromOptions, setMatType, setOptionsPrefix, setPointSF, setType, setUp, setVecType, view

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

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

Properties [hide private]

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