![]() |
Dendro
5.01
Dendro in Greek language means tree. The Dendro library is a large scale (262K cores on ORNL's Titan) distributed memory adaptive octree framework. The main goal of Dendro is to perform large scale multiphysics simulations efficeiently in mordern supercomputers. Dendro consists of efficient parallel data structures and algorithms to perform variational ( finite element) methods and finite difference mthods on 2:1 balanced arbitary adaptive octrees which enables the users to perform simulations raning from black holes (binary black hole mergers) to blood flow in human body, where applications ranging from relativity, astrophysics to biomedical engineering.
|
This is the complete list of members for ot::DA, including all inherited members.
computeTreeNodeOwnerProc(const ot::TreeNode *pNodes, unsigned int n, int *ownerranks) | ot::DA | |
copyVector(T *dest, const T *source, bool isElemental=false, bool isGhosted=false) const | ot::DA | |
copyVectors(T *dest, const T *source, bool isElemental=false, bool isGhosted=false, unsigned int dof=1) const | ot::DA | |
createVector(T *&local, bool isElemental=false, bool isGhosted=false, unsigned int dof=1) const | ot::DA | |
createVector(std::vector< T > &local, bool isElemental=false, bool isGhosted=false, unsigned int dof=1) const | ot::DA | |
curr() | ot::DA | |
DA(std::vector< ot::TreeNode > &balOct, MPI_Comm comm, unsigned int order, unsigned int grainSz=100, double sfc_tol=0.3, SM_TYPE smType=SM_TYPE::FEM_CG) | ot::DA | |
DA(ot::Mesh *pMesh) | ot::DA | |
DA(std::function< void(T, T, T, T *)>func, unsigned int dofSz, MPI_Comm comm, unsigned int order, double interp_tol, unsigned int grainSz=100, double sfc_tol=0.3, SM_TYPE smType=SM_TYPE::FEM_CG) | ot::DA | |
DA(const Point *pts, unsigned int numPts, Point pt_min, Point pt_max, MPI_Comm comm, unsigned int order, unsigned int grainSz=100, double sfc_tol=0.3, SM_TYPE smType=SM_TYPE::FEM_CG) | ot::DA | |
destroyVector(T *&local) const | ot::DA | |
destroyVector(std::vector< T > &local) const (defined in ot::DA) | ot::DA | |
eleVecToVecAccumilation(T *out, const T *eleVecIn, unsigned int eleID, unsigned int dof=1) const | ot::DA | |
end() | ot::DA | |
getBlocks() | ot::DA | |
getCommActive() const | ot::DA | inline |
getDimension() const | ot::DA | inline |
getElementalCoords(unsigned int eleID, double *coords) const | ot::DA | |
getElementNodalValues(const T *in, T *eleVecOut, unsigned int eleID, unsigned int dof=1) const | ot::DA | |
getElementOrder() const | ot::DA | inline |
getElementSize() const | ot::DA | inline |
getFaceNeighborValues(unsigned int eleID, const T *in, T *out, T *coords, unsigned int *neighID, unsigned int face, NeighbourLevel &level, unsigned int dof) const | ot::DA | |
getGhostedElementSize() const | ot::DA | inline |
getGlobalComm() const | ot::DA | inline |
getGlobalNodeIndices(DendroIntL *nodeIdx, unsigned int ele) const | ot::DA | |
getLevel(unsigned int ele) const | ot::DA | inline |
getLocalElemSz() const | ot::DA | inline |
getLocalNodalSz() const | ot::DA | inline |
getLocalOctants() | ot::DA | |
getMaxDepth() const | ot::DA | inline |
getMaxTreeNode() const | ot::DA | inline |
getMesh() const | ot::DA | inline |
getMinTreeNode() const | ot::DA | inline |
getMortonChildNum(unsigned int eleID) const | ot::DA | inline |
getNodeIndices(DendroIntL *nodeIdx, unsigned int ele, bool isGhosted) const | ot::DA | |
getNodeLocalToGlobalMap() const | ot::DA | inline |
getNpesActive() const | ot::DA | inline |
getNpesAll() const | ot::DA | inline |
getNumLayer1GhostEleSz() const | ot::DA | inline |
getNumNodesPerElement() const | ot::DA | inline |
getOctant(unsigned int ele) const | ot::DA | inline |
getOctFlags() const | ot::DA | inline |
getOctreeBoundaryNodeIndices(std::vector< unsigned int > &bdyIndex, std::vector< double > &coords, bool isGhosted=false) | ot::DA | |
getPostGhostElementSize() const | ot::DA | inline |
getPostNodalSz() const | ot::DA | inline |
getPreAndPostGhostNodeSize() const | ot::DA | inline |
getPreGhostElementSize() const | ot::DA | inline |
getPreNodalSz() const | ot::DA | inline |
getRankActive() const | ot::DA | inline |
getRankAll() const | ot::DA | inline |
getReferenceElement() const | ot::DA | inline |
getTotalElemSz() const | ot::DA | inline |
getTotalNodalSz() const | ot::DA | inline |
getVecPointerToDof(T *in, unsigned int dofInex, bool isElemental=false, bool isGhosted=false) const | ot::DA | |
ghostedNodalToNodalVec(const T *gVec, T *&local, bool isAllocated=false, unsigned int dof=1) const | ot::DA | |
init() | ot::DA | |
intergridTransfer(const T *varIn, T *&varOut, const ot::DA *newDA, bool isElemental=false, bool isGhosted=false, unsigned int dof=1) | ot::DA | |
isActive() const | ot::DA | inline |
isBoundaryOctant(unsigned int eleID) const | ot::DA | |
next() | ot::DA | |
nodalVecToGhostedNodal(const T *in, T *&out, bool isAllocated=false, unsigned int dof=1) const | ot::DA | |
readFromGhostBegin(T *vec, unsigned int dof=1) | ot::DA | |
readFromGhostEnd(T *vec, unsigned int dof=1) | ot::DA | |
remesh(const DA_FLAGS::Refine *flags, unsigned int sz, unsigned int grainSz=100, double ld_bal=0.3, unsigned int sfK=2, unsigned int(*getWeight)(const ot::TreeNode *)=NULL) const | ot::DA | |
setVectorByFunction(T *local, std::function< void(T, T, T, T *)>func, bool isElemental=false, bool isGhosted=false, unsigned int dof=1) const | ot::DA | |
setVectorByScalar(T *local, const T *value, bool isElemental=false, bool isGhosted=false, unsigned int dof=1) const | ot::DA | |
vecTopvtu(T *local, const char *fPrefix, char **nodalVarNames=NULL, bool isElemental=false, bool isGhosted=false, unsigned int dof=1) | ot::DA | |
writeToGhostsBegin(T *vec, unsigned int dof=1) | ot::DA | |
writeToGhostsEnd(T *vec, DA_FLAGS::WriteMode mode, unsigned int dof=1) | ot::DA | |
~DA() | ot::DA |