MFEM  v3.0
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Pages
mfem::Mesh Member List

This is the complete list of members for mfem::Mesh, including all inherited members.

AddBdrQuad(const int *vi, int attr=1)mfem::Mesh
AddBdrQuadAsTriangles(const int *vi, int attr=1)mfem::Mesh
AddBdrSegment(const int *vi, int attr=1)mfem::Mesh
AddBdrTriangle(const int *vi, int attr=1)mfem::Mesh
AddElement(Element *elem)mfem::Meshinline
AddHex(const int *vi, int attr=1)mfem::Mesh
AddHexAsTets(const int *vi, int attr=1)mfem::Mesh
AddPointFaceElement(int lf, int gf, int el)mfem::Meshprotected
AddQuad(const int *vi, int attr=1)mfem::Mesh
AddQuadFaceElement(int lf, int gf, int el, int v0, int v1, int v2, int v3)mfem::Meshprotected
AddSegmentFaceElement(int lf, int gf, int el, int v0, int v1)mfem::Meshprotected
AddTet(const int *vi, int attr=1)mfem::Mesh
AddTri(const int *vi, int attr=1)mfem::Mesh
AddTriangle(const int *vi, int attr=1)mfem::Mesh
AddTriangleFaceElement(int lf, int gf, int el, int v0, int v1, int v2)mfem::Meshprotected
AddVertex(const double *)mfem::Mesh
attributesmfem::Mesh
AverageVertices(int *indexes, int n, int result)mfem::Meshprotected
bdr_attributesmfem::Mesh
be_to_edgemfem::Meshprotected
be_to_facemfem::Meshprotected
bel_to_edgemfem::Meshprotected
BEMemorymfem::Meshprotected
Bisection(int i, const DSTable &, int *, int *, int *)mfem::Meshprotected
Bisection(int i, const DSTable &, int *)mfem::Meshprotected
BisectTetTrans(DenseMatrix &pointmat, Tetrahedron *tet, int child)mfem::Meshprotected
BisectTriTrans(DenseMatrix &pointmat, Triangle *tri, int child)mfem::Meshprotected
boundarymfem::Meshprotected
c_bel_to_edgemfem::Meshprotected
c_el_to_edgemfem::Meshprotected
c_el_to_facemfem::Meshprotected
c_NumOfBdrElementsmfem::Meshprotected
c_NumOfEdgesmfem::Meshprotected
c_NumOfElementsmfem::Meshprotected
c_NumOfFacesmfem::Meshprotected
c_NumOfVerticesmfem::Meshprotected
CartesianPartitioning(int nxyz[])mfem::Mesh
CheckBdrElementOrientation(bool fix_it=true)mfem::Mesh
CheckDisplacements(const Vector &displacements, double &tmax)mfem::Mesh
CheckElementOrientation(bool fix_it=true)mfem::Mesh
CheckPartitioning(int *partitioning)mfem::Mesh
DegreeElevate(int t)mfem::Mesh
DeleteCoarseTables()mfem::Meshprotected
DeleteTables()mfem::Meshprotected
Dimmfem::Meshprotected
Dimension() const mfem::Meshinline
DoNodeReorder(DSTable *old_v_to_v, Table *old_elem_vert)mfem::Meshprotected
edge_vertexmfem::Meshmutableprotected
EdgeTransformationmfem::Meshprotected
el_to_edgemfem::Meshprotected
el_to_elmfem::Meshprotected
el_to_facemfem::Meshprotected
elementsmfem::Meshprotected
ElementToEdgeTable() const mfem::Mesh
ElementToElementTable()mfem::Mesh
ElementToFaceTable() const mfem::Mesh
EulerNumber() const mfem::Meshinline
EulerNumber2D() const mfem::Meshinline
f_bel_to_edgemfem::Meshprotected
f_el_to_edgemfem::Meshprotected
f_el_to_facemfem::Meshprotected
f_NumOfBdrElementsmfem::Meshprotected
f_NumOfEdgesmfem::Meshprotected
f_NumOfElementsmfem::Meshprotected
f_NumOfFacesmfem::Meshprotected
f_NumOfVerticesmfem::Meshprotected
face_edgemfem::Meshmutableprotected
FaceElemTrmfem::Meshprotected
FaceIsInterior(int FaceNo) const mfem::Meshinline
FaceIsTrueInterior(int FaceNo) const mfem::Meshinlineprotected
facesmfem::Meshprotected
faces_infomfem::Meshprotected
FaceTransformationmfem::Meshprotected
fc_be_to_edgemfem::Meshprotected
fc_faces_infomfem::Meshprotected
FinalizeHexMesh(int generate_edges=0, int refine=0, bool fix_orientation=true)mfem::Mesh
FinalizeQuadMesh(int generate_edges=0, int refine=0, bool fix_orientation=true)mfem::Mesh
FinalizeTetMesh(int generate_edges=0, int refine=0, bool fix_orientation=true)mfem::Mesh
FinalizeTriMesh(int generate_edges=0, int refine=0, bool fix_orientation=true)mfem::Mesh
FreeElement(Element *E)mfem::Meshprotected
GeneralRefinement(Array< Refinement > &refinements, int nonconforming=-1, int nc_limit=0)mfem::Mesh
GeneralRefinement(Array< int > &el_to_refine, int nonconforming=-1, int nc_limit=0)mfem::Mesh
GenerateBoundaryElements()mfem::Mesh
GenerateFaces()mfem::Meshprotected
GeneratePartitioning(int nparts, int part_method=1)mfem::Mesh
GetAttribute(int i) const mfem::Meshinline
GetBdrAttribute(int i) const mfem::Meshinline
GetBdrElement(int i) const mfem::Meshinline
GetBdrElement(int i)mfem::Meshinline
GetBdrElementBaseGeometry(int i) const mfem::Meshinline
GetBdrElementEdgeIndex(int i) const mfem::Mesh
GetBdrElementEdges(int i, Array< int > &, Array< int > &) const mfem::Mesh
GetBdrElementFace(int i, int *, int *) const mfem::Mesh
GetBdrElementTransformation(int i)mfem::Mesh
GetBdrElementTransformation(int i, IsoparametricTransformation *ElTr)mfem::Mesh
GetBdrElementType(int i) const mfem::Mesh
GetBdrElementVertices(int i, Array< int > &dofs) const mfem::Meshinline
GetBdrFaceTransformations(int BdrElemNo)mfem::Mesh
GetBdrPointMatrix(int i, DenseMatrix &pointmat) const mfem::Mesh
GetBisectionHierarchy(Element *E)mfem::Meshprotected
GetEdgeOrdering(DSTable &v_to_v, Array< int > &order)mfem::Meshprotected
GetEdgeTransformation(int i, IsoparametricTransformation *EdTr)mfem::Mesh
GetEdgeTransformation(int EdgeNo)mfem::Mesh
GetEdgeVertexTable() const mfem::Mesh
GetEdgeVertices(int i, Array< int > &vert) const mfem::Mesh
GetElement(int i) const mfem::Meshinline
GetElement(int i)mfem::Meshinline
GetElementArrayEdgeTable(const Array< Element * > &elem_array, const DSTable &v_to_v, Table &el_to_edge)mfem::Meshprotectedstatic
GetElementBaseGeometry(int i) const mfem::Meshinline
GetElementColoring(Array< int > &colors, int el0=0)mfem::Mesh
GetElementEdges(int i, Array< int > &, Array< int > &) const mfem::Mesh
GetElementFaces(int i, Array< int > &, Array< int > &) const mfem::Mesh
GetElementJacobian(int i, DenseMatrix &J)mfem::Meshprotected
GetElementSize(int i, int type=0)mfem::Mesh
GetElementSize(int i, const Vector &dir)mfem::Mesh
GetElementToEdgeTable(Table &, Array< int > &)mfem::Meshprotected
GetElementToFaceTable(int ret_ftbl=0)mfem::Meshprotected
GetElementTransformation(int i, IsoparametricTransformation *ElTr)mfem::Mesh
GetElementTransformation(int i)mfem::Mesh
GetElementTransformation(int i, const Vector &nodes, IsoparametricTransformation *ElTr)mfem::Mesh
GetElementType(int i) const mfem::Mesh
GetElementVertices(int i, Array< int > &dofs) const mfem::Meshinline
GetElementVolume(int i)mfem::Mesh
GetFace(int i) const mfem::Meshinline
GetFaceBaseGeometry(int i) const mfem::Mesh
GetFaceEdges(int i, Array< int > &, Array< int > &) const mfem::Mesh
GetFaceEdgeTable() const mfem::Mesh
GetFaceElements(int Face, int *Elem1, int *Elem2)mfem::Mesh
GetFaceElementTransformations(int FaceNo, int mask=31)mfem::Mesh
GetFaceInfos(int Face, int *Inf1, int *Inf2)mfem::Mesh
GetFacesTable()mfem::Meshprotected
GetFaceToElementTable() const mfem::Mesh
GetFaceTransformation(int i, IsoparametricTransformation *FTr)mfem::Mesh
GetFaceTransformation(int FaceNo)mfem::Mesh
GetFaceVertices(int i, Array< int > &vert) const mfem::Meshinline
GetFineElem(int i, int j)mfem::Mesh
GetFineElemPath(int i, int j)mfem::Meshprotected
GetFineElemTrans(int i, int j)mfem::Mesh
GetInteriorFaceTransformations(int FaceNo)mfem::Meshinline
GetLength(int i, int j) const mfem::Meshprotected
GetLocalPtToSegTransformation(IsoparametricTransformation &, int)mfem::Meshprotected
GetLocalQuadToHexTransformation(IsoparametricTransformation &loc, int i)mfem::Meshprotected
GetLocalSegToQuadTransformation(IsoparametricTransformation &loc, int i)mfem::Meshprotected
GetLocalSegToTriTransformation(IsoparametricTransformation &loc, int i)mfem::Meshprotected
GetLocalTriToTetTransformation(IsoparametricTransformation &loc, int i)mfem::Meshprotected
GetNBE() const mfem::Meshinline
GetNE() const mfem::Meshinline
GetNEdges() const mfem::Meshinline
GetNFaces() const mfem::Meshinline
GetNodalFESpace()mfem::Mesh
GetNode(int i, double *coord)mfem::Mesh
GetNodes(Vector &node_coord) const mfem::Mesh
GetNodes()mfem::Meshinline
GetNodes(GridFunction &nodes) const mfem::Mesh
GetNumFaces() const mfem::Mesh
GetNumFineElems(int i)mfem::Mesh
GetNV() const mfem::Meshinline
GetPointMatrix(int i, DenseMatrix &pointmat) const mfem::Mesh
GetQuadOrientation(const int *base, const int *test)mfem::Meshprotectedstatic
GetRefinementType(int i)mfem::Mesh
GetState() const mfem::Meshinline
GetTransformationFEforElementType(int)mfem::Meshstatic
GetTriOrientation(const int *base, const int *test)mfem::Meshprotectedstatic
GetVertex(int i) const mfem::Meshinline
GetVertex(int i)mfem::Meshinline
GetVertexToElementTable()mfem::Mesh
GetVertexToVertexTable(DSTable &) const mfem::Meshprotected
GetVertices(Vector &vert_coord) const mfem::Mesh
GreenRefinement(int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle)mfem::Meshinlineprotected
hex_facesmfem::Meshprotectedstatic
HexUniformRefinement()mfem::Meshprotectedvirtual
Init()mfem::Meshprotected
InitMesh(int _Dim, int _spaceDim, int NVert, int NElem, int NBdrElem)mfem::Meshprotected
InitTables()mfem::Meshprotected
KnotInsert(Array< KnotVector * > &kv)mfem::Mesh
Load(std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true)mfem::Mesh
LoadPatchTopo(std::istream &input, Array< int > &edge_to_knot)mfem::Meshprotected
LocalRefinement(const Array< int > &marked_el, int type=3)mfem::Meshprotectedvirtual
Make1D(int n, double sx=1.0)mfem::Meshprotected
Make2D(int nx, int ny, Element::Type type, int generate_edges, double sx, double sy)mfem::Meshprotected
Make3D(int nx, int ny, int nz, Element::Type type, int generate_edges, double sx, double sy, double sz)mfem::Meshprotected
MarkForRefinement()mfem::Meshprotected
MarkTetMeshForRefinement()mfem::Meshprotected
MarkTriMeshForRefinement()mfem::Meshprotected
Mesh(NCMesh &ncmesh)mfem::Meshprotected
Mesh()mfem::Meshinline
Mesh(int _Dim, int NVert, int NElem, int NBdrElem=0, int _spaceDim=-1)mfem::Meshinline
Mesh(int nx, int ny, int nz, Element::Type type, int generate_edges=0, double sx=1.0, double sy=1.0, double sz=1.0)mfem::Meshinline
Mesh(int nx, int ny, Element::Type type, int generate_edges=0, double sx=1.0, double sy=1.0)mfem::Meshinline
Mesh(int n, double sx=1.0)mfem::Meshinlineexplicit
Mesh(std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true)mfem::Mesh
Mesh(Mesh *mesh_array[], int num_pieces)mfem::Mesh
meshgenmfem::Meshprotected
MeshGenerator()mfem::Meshinline
MesquiteSmooth(const int mesquite_option=0)mfem::Mesh
MoveNodes(const Vector &displacements)mfem::Mesh
MoveVertices(const Vector &displacements)mfem::Mesh
nc_coarse_levelmfem::Meshprotected
ncmeshmfem::Mesh
NewElement(int geom)mfem::Mesh
NewNodes(GridFunction &nodes, bool make_owner=false)mfem::Mesh
Nodesmfem::Meshprotected
NonconformingRefinement(const Array< Refinement > &refinements, int nc_limit=0)mfem::Meshprotected
NORMAL enum valuemfem::Mesh
NumOfBdrElementsmfem::Meshprotected
NumOfEdgesmfem::Meshprotected
NumOfElementsmfem::Meshprotected
NumOfFacesmfem::Meshprotected
NumOfVerticesmfem::Meshprotected
NURBSextmfem::Mesh
NURBSExtension classmfem::Meshfriend
NURBSUniformRefinement()mfem::Meshprotectedvirtual
own_nodesmfem::Meshprotected
ParMesh classmfem::Meshfriend
PrepareNodeReorder(DSTable **old_v_to_v, Table **old_elem_vert)mfem::Meshprotected
Print(std::ostream &out=std::cout) const mfem::Meshvirtual
PrintCharacteristics(Vector *Vh=NULL, Vector *Vk=NULL)mfem::Mesh
PrintElement(const Element *, std::ostream &)mfem::Meshprotectedstatic
PrintElementsWithPartitioning(int *partitioning, std::ostream &out, int interior_faces=0)mfem::Mesh
PrintElementWithoutAttr(const Element *, std::ostream &)mfem::Meshprotectedstatic
PrintSurfaces(const Table &Aface_face, std::ostream &out) const mfem::Mesh
PrintTopo(std::ostream &out, const Array< int > &e_to_k) const mfem::Meshprotected
PrintVTK(std::ostream &out)mfem::Mesh
PrintVTK(std::ostream &out, int ref, int field_data=0)mfem::Mesh
PrintWithPartitioning(int *partitioning, std::ostream &out, int elem_attr=0) const mfem::Mesh
PrintXG(std::ostream &out=std::cout) const mfem::Meshvirtual
quad_orientationsmfem::Meshprotectedstatic
QuadUniformRefinement()mfem::Meshprotectedvirtual
ReadElement(std::istream &)mfem::Meshprotected
ReadElementWithoutAttr(std::istream &)mfem::Meshprotected
RedRefinement(int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle)mfem::Meshinlineprotected
ReorientTetMesh()mfem::Meshvirtual
Rotate3(int &, int &, int &)mfem::Meshinlineprotectedstatic
ScaleElements(double sf)mfem::Mesh
ScaleSubdomains(double sf)mfem::Mesh
SetAttributes()mfem::Mesh
SetMeshGen()mfem::Meshprotected
SetNodalFESpace(FiniteElementSpace *nfes)mfem::Mesh
SetNodalGridFunction(GridFunction *nodes, bool make_owner=false)mfem::Mesh
SetNode(int i, const double *coord)mfem::Mesh
SetNodes(const Vector &node_coord)mfem::Mesh
SetState(int s)mfem::Mesh
SetVertices(const Vector &vert_coord)mfem::Mesh
ShiftL2R(int &, int &, int &)mfem::Meshinlineprotectedstatic
spaceDimmfem::Meshprotected
SpaceDimension() const mfem::Meshinline
Statemfem::Meshprotected
Swap(Mesh &other, bool non_geometry=false)mfem::Meshprotected
SwapNodes(GridFunction *&nodes, int &own_nodes_)mfem::Mesh
tet_facesmfem::Meshprotectedstatic
TetMemorymfem::Meshprotected
Tetrahedron classmfem::Meshfriend
Transform(void(*f)(const Vector &, Vector &))mfem::Mesh
Transformationmfem::Meshprotected
Transformation2mfem::Meshprotected
tri_orientationsmfem::Meshprotectedstatic
TWO_LEVEL_COARSE enum valuemfem::Mesh
TWO_LEVEL_FINE enum valuemfem::Mesh
UniformRefinement(int i, const DSTable &, int *, int *, int *)mfem::Meshprotected
UniformRefinement()mfem::Mesh
UpdateNodes()mfem::Meshprotected
UpdateNURBS()mfem::Meshprotected
UseTwoLevelState(int use)mfem::Meshinline
verticesmfem::Meshprotected
WantTwoLevelStatemfem::Meshprotected
~Mesh()mfem::Meshvirtual