MFEM  v3.4
Finite element discretization library
 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.

AddBdrElement(Element *elem)mfem::Meshinline
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
ApplyLocalSlaveTransformation(IsoparametricTransformation &transf, const FaceInfo &fi)mfem::Meshprotected
attributesmfem::Mesh
AverageVertices(int *indexes, int n, int result)mfem::Meshprotected
BaseBdrGeommfem::Meshprotected
BaseGeommfem::Meshprotected
bdr_attributesmfem::Mesh
be_to_edgemfem::Meshprotected
be_to_facemfem::Meshprotected
bel_to_edgemfem::Meshprotected
Bisection(int i, const DSTable &, int *, int *, int *)mfem::Meshprotected
Bisection(int i, const DSTable &, int *)mfem::Meshprotected
boundarymfem::Meshprotected
CartesianPartitioning(int nxyz[])mfem::Mesh
ChangeVertexDataOwnership(double *vertices, int len_vertices, bool zerocopy=false)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
Clear()mfem::Meshinline
CoarseFineTrmfem::Meshprotected
Conforming() const mfem::Meshinline
DegreeElevate(int rel_degree, int degree=16)mfem::Mesh
DeleteLazyTables()mfem::Meshprotected
DeleteTables()mfem::Meshinlineprotected
DEREFINE enum valuemfem::Mesh
DerefineByError(Array< double > &elem_error, double threshold, int nc_limit=0, int op=1)mfem::Mesh
DerefineByError(const Vector &elem_error, double threshold, int nc_limit=0, int op=1)mfem::Mesh
DerefineMesh(const Array< int > &derefinements)mfem::Meshprotected
Destroy()mfem::Meshprotected
DestroyPointers()mfem::Meshprotected
DestroyTables()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
EnsureNCMesh(bool triangles_nonconforming=false)mfem::Mesh
EulerNumber() const mfem::Meshinline
EulerNumber2D() const mfem::Meshinline
face_edgemfem::Meshmutableprotected
FaceElemTrmfem::Meshprotected
FaceIsInterior(int FaceNo) const mfem::Meshinline
FaceIsTrueInterior(int FaceNo) const mfem::Meshinlineprotected
facesmfem::Meshprotected
faces_infomfem::Meshprotected
FaceTransformationmfem::Meshprotected
Finalize(bool refine=false, bool fix_orientation=false)mfem::Mesh
FinalizeCheck()mfem::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
FinalizeTopology()mfem::Mesh
FinalizeTriMesh(int generate_edges=0, int refine=0, bool fix_orientation=true)mfem::Mesh
FindCoarseElement(int i)mfem::Meshprotected
FindPoints(DenseMatrix &point_mat, Array< int > &elem_ids, Array< IntegrationPoint > &ips, bool warn=true, InverseElementTransformation *inv_trans=NULL)mfem::Meshvirtual
FreeElement(Element *E)mfem::Meshprotected
GeneralRefinement(const Array< Refinement > &refinements, int nonconforming=-1, int nc_limit=0)mfem::Mesh
GeneralRefinement(const Array< int > &el_to_refine, int nonconforming=-1, int nc_limit=0)mfem::Mesh
GenerateBoundaryElements()mfem::Mesh
GenerateFaces()mfem::Meshprotected
GenerateNCFaceInfo()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
GetBdrElementAdjacentElement(int bdr_el, int &el, int &info) const mfem::Mesh
GetBdrElementBaseGeometry(int i=0) const mfem::Meshinline
GetBdrElementData(int geom, Array< int > &bdr_elem_vtx, Array< int > &bdr_attr) const mfem::Meshinline
GetBdrElementEdgeIndex(int i) const mfem::Mesh
GetBdrElementEdges(int i, Array< int > &edges, Array< int > &cor) 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 > &v) const mfem::Meshinline
GetBdrFaceTransformations(int BdrElemNo)mfem::Mesh
GetBdrPointMatrix(int i, DenseMatrix &pointmat) const mfem::Mesh
GetBoundingBox(Vector &min, Vector &max, int ref=2)mfem::Mesh
GetCharacteristics(double &h_min, double &h_max, double &kappa_min, double &kappa_max, Vector *Vh=NULL, Vector *Vk=NULL)mfem::Mesh
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=0) const mfem::Meshinline
GetElementColoring(Array< int > &colors, int el0=0)mfem::Mesh
GetElementData(const Array< Element * > &elem_array, int geom, Array< int > &elem_vtx, Array< int > &attr) const mfem::Meshprotected
GetElementData(int geom, Array< int > &elem_vtx, Array< int > &attr) const mfem::Meshinline
GetElementEdges(int i, Array< int > &edges, Array< int > &cor) const mfem::Mesh
GetElementFaces(int i, Array< int > &, Array< int > &) const mfem::Mesh
GetElementJacobian(int i, DenseMatrix &J)mfem::Meshprotected
GetElementsArray() const mfem::Meshinline
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 > &v) 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
GetFaceElementType(int Face) const mfem::Mesh
GetFaceGeometryType(int Face) const 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
GetGeckoElementReordering(Array< int > &ordering)mfem::Mesh
GetGlobalNE() const mfem::Meshinline
GetInteriorFaceTransformations(int FaceNo)mfem::Meshinline
GetLastOperation() const mfem::Meshinline
GetLength(int i, int j) const mfem::Meshprotected
GetLocalFaceTransformation(int face_type, int elem_type, IsoparametricTransformation &Transf, int info)mfem::Mesh
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() const mfem::Mesh
GetNode(int i, double *coord)mfem::Mesh
GetNodes(Vector &node_coord) const mfem::Mesh
GetNodes()mfem::Meshinline
GetNodes() const mfem::Meshinline
GetNodes(GridFunction &nodes) const mfem::Mesh
GetNumFaces() const mfem::Mesh
GetNV() const mfem::Meshinline
GetPointMatrix(int i, DenseMatrix &pointmat) const mfem::Mesh
GetQuadOrientation(const int *base, const int *test)mfem::Meshprotectedstatic
GetRefinementTransforms()mfem::Mesh
GetSequence() 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_t typedefmfem::Mesh
HexUniformRefinement()mfem::Meshprotectedvirtual
Init()mfem::Meshprotected
InitBaseGeom()mfem::Meshprotected
InitFromNCMesh(const NCMesh &ncmesh)mfem::Meshprotected
InitMesh(int _Dim, int _spaceDim, int NVert, int NElem, int NBdrElem)mfem::Meshprotected
InitRefinementTransforms()mfem::Meshprotected
InitTables()mfem::Meshprotected
IsSlaveFace(const FaceInfo &fi) const mfem::Meshprotected
KnotInsert(Array< KnotVector * > &kv)mfem::Mesh
last_operationmfem::Meshprotected
Load(std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true)mfem::Meshinlinevirtual
Loader(std::istream &input, int generate_edges=0, std::string parse_tag="")mfem::Meshprotected
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(DSTable &v_to_v)mfem::Meshprotectedvirtual
MarkTriMeshForRefinement()mfem::Meshprotected
Mesh(const NCMesh &ncmesh)mfem::Meshexplicitprotected
Mesh()mfem::Meshinline
Mesh(const Mesh &mesh, bool copy_nodes=true)mfem::Meshexplicit
Mesh(double *vertices, int num_vertices, int *element_indices, Geometry::Type element_type, int *element_attributes, int num_elements, int *boundary_indices, Geometry::Type boundary_type, int *boundary_attributes, int num_boundary_elements, int dimension, int space_dimension=-1)mfem::Mesh
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(const char *filename, int generate_edges=0, int refine=1, bool fix_orientation=true)mfem::Meshexplicit
Mesh(std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true)mfem::Meshexplicit
Mesh(Mesh *mesh_array[], int num_pieces)mfem::Mesh
Mesh(Mesh *orig_mesh, int ref_factor, int ref_type)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_faces_infomfem::Meshprotected
ncmeshmfem::Mesh
NewElement(int geom)mfem::Mesh
NewNodes(GridFunction &nodes, bool make_owner=false)mfem::Mesh
Nodesmfem::Meshprotected
Nonconforming() const mfem::Meshinline
NonconformingDerefinement(Array< double > &elem_error, double threshold, int nc_limit=0, int op=1)mfem::Meshprotectedvirtual
NonconformingRefinement(const Array< Refinement > &refinements, int nc_limit=0)mfem::Meshprotectedvirtual
NONE enum valuemfem::Mesh
NumOfBdrElementsmfem::Meshprotected
NumOfEdgesmfem::Meshprotected
NumOfElementsmfem::Meshprotected
NumOfFacesmfem::Meshprotected
NumOfVerticesmfem::Meshprotected
NURBSextmfem::Mesh
NURBSExtension classmfem::Meshfriend
NURBSUniformRefinement()mfem::Meshprotectedvirtual
Operation enum namemfem::Mesh
own_nodesmfem::Meshprotected
OwnsNodes() const mfem::Meshinline
ParMesh classmfem::Meshfriend
ParNCMesh classmfem::Meshfriend
PrepareNodeReorder(DSTable **old_v_to_v, Table **old_elem_vert)mfem::Meshprotected
Print(std::ostream &out=mfem::out) const mfem::Meshinlinevirtual
PrintCharacteristics(Vector *Vh=NULL, Vector *Vk=NULL, std::ostream &out=mfem::out)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
Printer(std::ostream &out=mfem::out, std::string section_delimiter="") const mfem::Meshprotected
PrintInfo(std::ostream &out=mfem::out)mfem::Meshinlinevirtual
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=mfem::out) const mfem::Meshvirtual
quad_t typedefmfem::Mesh
QuadUniformRefinement()mfem::Meshprotectedvirtual
RandomRefinement(double prob, bool aniso=false, int nonconforming=-1, int nc_limit=0)mfem::Mesh
ReadCubit(const char *filename, int &curved, int &read_gf)mfem::Meshprotected
ReadElement(std::istream &)mfem::Meshprotected
ReadElementWithoutAttr(std::istream &)mfem::Meshprotected
ReadGmshMesh(std::istream &input)mfem::Meshprotected
ReadInlineMesh(std::istream &input, int generate_edges=0)mfem::Meshprotected
ReadLineMesh(std::istream &input)mfem::Meshprotected
ReadMFEMMesh(std::istream &input, bool mfem_v11, int &curved)mfem::Meshprotected
ReadNetgen2DMesh(std::istream &input, int &curved)mfem::Meshprotected
ReadNetgen3DMesh(std::istream &input)mfem::Meshprotected
ReadNURBSMesh(std::istream &input, int &curved, int &read_gf)mfem::Meshprotected
ReadTrueGridMesh(std::istream &input)mfem::Meshprotected
ReadVTKMesh(std::istream &input, int &curved, int &read_gf)mfem::Meshprotected
REBALANCE enum valuemfem::Mesh
RedRefinement(int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle)mfem::Meshinlineprotected
ReduceInt(int value) const mfem::Meshinlinevirtual
REFINE enum valuemfem::Mesh
RefineAtVertex(const Vertex &vert, double eps=0.0, int nonconforming=-1)mfem::Mesh
RefineByError(const Array< double > &elem_error, double threshold, int nonconforming=-1, int nc_limit=0)mfem::Mesh
RefineByError(const Vector &elem_error, double threshold, int nonconforming=-1, int nc_limit=0)mfem::Mesh
remove_unused_verticesmfem::Meshstatic
RemoveInternalBoundaries()mfem::Mesh
RemoveUnusedVertices()mfem::Mesh
ReorderElements(const Array< int > &ordering, bool reorder_vertices=true)mfem::Mesh
ReorientTetMesh()mfem::Meshvirtual
Rotate3(int &, int &, int &)mfem::Meshinlineprotectedstatic
ScaleElements(double sf)mfem::Mesh
ScaleSubdomains(double sf)mfem::Mesh
seg_t typedefmfem::Mesh
sequencemfem::Meshprotected
SetAttribute(int i, int attr)mfem::Meshinline
SetAttributes()mfem::Mesh
SetCurvature(int order, bool discont=false, int space_dim=-1, int ordering=1)mfem::Mesh
SetEmpty()mfem::Meshprotected
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
SetNodesOwner(bool nodes_owner)mfem::Meshinline
SetVertices(const Vector &vert_coord)mfem::Mesh
ShiftL2R(int &, int &, int &)mfem::Meshinlineprotectedstatic
spaceDimmfem::Meshprotected
SpaceDimension() const mfem::Meshinline
Swap(Mesh &other, bool non_geometry=false)mfem::Meshprotected
SwapNodes(GridFunction *&nodes, int &own_nodes_)mfem::Mesh
tet_t typedefmfem::Mesh
TetMemorymfem::Meshprotected
Tetrahedron classmfem::Meshfriend
Transform(void(*f)(const Vector &, Vector &))mfem::Mesh
Transform(VectorCoefficient &deformation)mfem::Mesh
Transformationmfem::Meshprotected
Transformation2mfem::Meshprotected
tri_t typedefmfem::Mesh
UniformRefinement(int i, const DSTable &, int *, int *, int *)mfem::Meshprotected
UniformRefinement()mfem::Mesh
UpdateNodes()mfem::Meshprotected
UpdateNURBS()mfem::Meshprotected
verticesmfem::Meshprotected
vtk_quadratic_hexmfem::Meshprotectedstatic
vtk_quadratic_tetmfem::Meshprotectedstatic
~Mesh()mfem::Meshinlinevirtual