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

type 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, ...)
 
computeCellGeometryFVM(self, cell)
 
constructGhostCells(self, labelName=None)
 
create(self, comm=None)
 
createBoxMesh(self, faces, lower=(0, 0, 0), upper=(1, 1, 1), simplex=True, periodic=False, 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)
 
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)
 
createFromFile(self, filename, 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)
 
createSquareBoundary(self, lower, upper, edges)
 
distribute(self, overlap=0)
 
distributeField(self, SF sf, Section sec, Vec vec, Section newsec=None, Vec newvec=None)
 
distributeOverlap(self, overlap=0)
 
generate(self, DMPlex boundary, name=None, interpolate=True)
 
getAdjacency(self, p)
 
getAdjacencyUseAnchors(self)
 
getCellNumbering(self)
 
getChart(self)
 
getCone(self, p)
 
getConeOrientation(self, p)
 
getConeSize(self, p)
 
getDepth(self)
 
getDepthStratum(self, svalue)
 
getHeightStratum(self, svalue)
 
getJoin(self, points)
 
getMaxSizes(self)
 
getMeet(self, points)
 
getOrdering(self, otype)
 
getPartitioner(self)
 
getPointGlobal(self, point)
 
getPointGlobalField(self, point, field)
 
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)
 
insertCone(self, p, conePos, conePoint)
 
insertConeOrientation(self, p, conePos, coneOrientation)
 
interpolate(self)
 
markBoundaryFaces(self, label, value=None)
 
orient(self)
 
permute(self, IS perm)
 
rebalanceSharedPoints(self, entityDepth=0, useInitialGuess=True, parallel=True)
 
setAdjacencyUseAnchors(self, useAnchors=True)
 
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)
 
uninterpolate(self)
 
vecGetClosure(self, Section sec, Vec vec, p)

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

Properties [hide private]

Inherited from DM: appctx, ds

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

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