|
MFEM
v3.2
Finite element discretization library
|
This is the complete list of members for mfem::Mesh, including all inherited members.
| AddBdrElement(Element *elem) | mfem::Mesh | inline |
| 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::Mesh | inline |
| 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::Mesh | protected |
| 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::Mesh | protected |
| AddSegmentFaceElement(int lf, int gf, int el, int v0, int v1) | mfem::Mesh | protected |
| 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::Mesh | protected |
| AddVertex(const double *) | mfem::Mesh | |
| ApplyLocalSlaveTransformation(IsoparametricTransformation &transf, const FaceInfo &fi) | mfem::Mesh | protected |
| attributes | mfem::Mesh | |
| AverageVertices(int *indexes, int n, int result) | mfem::Mesh | protected |
| BaseBdrGeom | mfem::Mesh | protected |
| BaseGeom | mfem::Mesh | protected |
| bdr_attributes | mfem::Mesh | |
| be_to_edge | mfem::Mesh | protected |
| be_to_face | mfem::Mesh | protected |
| bel_to_edge | mfem::Mesh | protected |
| Bisection(int i, const DSTable &, int *, int *, int *) | mfem::Mesh | protected |
| Bisection(int i, const DSTable &, int *) | mfem::Mesh | protected |
| boundary | mfem::Mesh | protected |
| 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 | |
| CoarseFineTr | mfem::Mesh | protected |
| Conforming() const | mfem::Mesh | inline |
| DegreeElevate(int t) | mfem::Mesh | |
| DeleteTables() | mfem::Mesh | protected |
| DEREFINE enum value | mfem::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::Mesh | protected |
| Dim | mfem::Mesh | protected |
| Dimension() const | mfem::Mesh | inline |
| DoNodeReorder(DSTable *old_v_to_v, Table *old_elem_vert) | mfem::Mesh | protected |
| edge_vertex | mfem::Mesh | mutableprotected |
| EdgeTransformation | mfem::Mesh | protected |
| el_to_edge | mfem::Mesh | protected |
| el_to_el | mfem::Mesh | protected |
| el_to_face | mfem::Mesh | protected |
| elements | mfem::Mesh | protected |
| ElementToEdgeTable() const | mfem::Mesh | |
| ElementToElementTable() | mfem::Mesh | |
| ElementToFaceTable() const | mfem::Mesh | |
| EnsureNCMesh(bool triangles_nonconforming=false) | mfem::Mesh | |
| EulerNumber() const | mfem::Mesh | inline |
| EulerNumber2D() const | mfem::Mesh | inline |
| face_edge | mfem::Mesh | mutableprotected |
| FaceElemTr | mfem::Mesh | protected |
| FaceIsInterior(int FaceNo) const | mfem::Mesh | inline |
| FaceIsTrueInterior(int FaceNo) const | mfem::Mesh | inlineprotected |
| faces | mfem::Mesh | protected |
| faces_info | mfem::Mesh | protected |
| FaceTransformation | mfem::Mesh | protected |
| filter_dos(std::string &line) | mfem::Mesh | inlineprotectedstatic |
| 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 | |
| FindCoarseElement(int i) | mfem::Mesh | protected |
| FreeElement(Element *E) | mfem::Mesh | protected |
| 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::Mesh | protected |
| GenerateNCFaceInfo() | mfem::Mesh | protected |
| GeneratePartitioning(int nparts, int part_method=1) | mfem::Mesh | |
| GetAttribute(int i) const | mfem::Mesh | inline |
| GetBdrAttribute(int i) const | mfem::Mesh | inline |
| GetBdrElement(int i) const | mfem::Mesh | inline |
| GetBdrElement(int i) | mfem::Mesh | inline |
| GetBdrElementAdjacentElement(int bdr_el, int &el, int &info) const | mfem::Mesh | |
| GetBdrElementBaseGeometry(int i=0) const | mfem::Mesh | inline |
| 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 > &dofs) const | mfem::Mesh | inline |
| GetBdrFaceTransformations(int BdrElemNo) | mfem::Mesh | |
| GetBdrPointMatrix(int i, DenseMatrix &pointmat) const | mfem::Mesh | |
| GetBoundingBox(Vector &min, Vector &max, int ref=2) | mfem::Mesh | |
| GetEdgeOrdering(DSTable &v_to_v, Array< int > &order) | mfem::Mesh | protected |
| 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::Mesh | inline |
| GetElement(int i) | mfem::Mesh | inline |
| GetElementArrayEdgeTable(const Array< Element * > &elem_array, const DSTable &v_to_v, Table &el_to_edge) | mfem::Mesh | protectedstatic |
| GetElementBaseGeometry(int i=0) const | mfem::Mesh | inline |
| GetElementColoring(Array< int > &colors, int el0=0) | mfem::Mesh | |
| 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::Mesh | protected |
| GetElementsArray() const | mfem::Mesh | inline |
| GetElementSize(int i, int type=0) | mfem::Mesh | |
| GetElementSize(int i, const Vector &dir) | mfem::Mesh | |
| GetElementToEdgeTable(Table &, Array< int > &) | mfem::Mesh | protected |
| GetElementToFaceTable(int ret_ftbl=0) | mfem::Mesh | protected |
| 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::Mesh | inline |
| GetElementVolume(int i) | mfem::Mesh | |
| GetFace(int i) const | mfem::Mesh | inline |
| 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::Mesh | protected |
| GetFaceToElementTable() const | mfem::Mesh | |
| GetFaceTransformation(int i, IsoparametricTransformation *FTr) | mfem::Mesh | |
| GetFaceTransformation(int FaceNo) | mfem::Mesh | |
| GetFaceVertices(int i, Array< int > &vert) const | mfem::Mesh | inline |
| GetGeckoElementReordering(Array< int > &ordering) | mfem::Mesh | |
| GetGlobalNE() const | mfem::Mesh | inline |
| GetInteriorFaceTransformations(int FaceNo) | mfem::Mesh | inline |
| GetLastOperation() const | mfem::Mesh | inline |
| GetLength(int i, int j) const | mfem::Mesh | protected |
| GetLocalFaceTransformation(int face_type, int elem_type, IsoparametricTransformation &Transf, int inf) | mfem::Mesh | protected |
| GetLocalPtToSegTransformation(IsoparametricTransformation &, int) | mfem::Mesh | protected |
| GetLocalQuadToHexTransformation(IsoparametricTransformation &loc, int i) | mfem::Mesh | protected |
| GetLocalSegToQuadTransformation(IsoparametricTransformation &loc, int i) | mfem::Mesh | protected |
| GetLocalSegToTriTransformation(IsoparametricTransformation &loc, int i) | mfem::Mesh | protected |
| GetLocalTriToTetTransformation(IsoparametricTransformation &loc, int i) | mfem::Mesh | protected |
| GetNBE() const | mfem::Mesh | inline |
| GetNE() const | mfem::Mesh | inline |
| GetNEdges() const | mfem::Mesh | inline |
| GetNFaces() const | mfem::Mesh | inline |
| GetNodalFESpace() const | mfem::Mesh | |
| GetNode(int i, double *coord) | mfem::Mesh | |
| GetNodes(Vector &node_coord) const | mfem::Mesh | |
| GetNodes() | mfem::Mesh | inline |
| GetNodes() const | mfem::Mesh | inline |
| GetNodes(GridFunction &nodes) const | mfem::Mesh | |
| GetNumFaces() const | mfem::Mesh | |
| GetNV() const | mfem::Mesh | inline |
| GetPointMatrix(int i, DenseMatrix &pointmat) const | mfem::Mesh | |
| GetQuadOrientation(const int *base, const int *test) | mfem::Mesh | protectedstatic |
| GetRefinementTransforms() | mfem::Mesh | |
| GetSequence() const | mfem::Mesh | inline |
| GetTransformationFEforElementType(int) | mfem::Mesh | static |
| GetTriOrientation(const int *base, const int *test) | mfem::Mesh | protectedstatic |
| GetVertex(int i) const | mfem::Mesh | inline |
| GetVertex(int i) | mfem::Mesh | inline |
| GetVertexToElementTable() | mfem::Mesh | |
| GetVertexToVertexTable(DSTable &) const | mfem::Mesh | protected |
| GetVertices(Vector &vert_coord) const | mfem::Mesh | |
| GreenRefinement(int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle) | mfem::Mesh | inlineprotected |
| hex_t typedef | mfem::Mesh | |
| HexUniformRefinement() | mfem::Mesh | protectedvirtual |
| Init() | mfem::Mesh | protected |
| InitBaseGeom() | mfem::Mesh | protected |
| InitFromNCMesh(const NCMesh &ncmesh) | mfem::Mesh | protected |
| InitMesh(int _Dim, int _spaceDim, int NVert, int NElem, int NBdrElem) | mfem::Mesh | protected |
| InitRefinementTransforms() | mfem::Mesh | protected |
| InitTables() | mfem::Mesh | protected |
| IsSlaveFace(const FaceInfo &fi) const | mfem::Mesh | protected |
| KnotInsert(Array< KnotVector * > &kv) | mfem::Mesh | |
| last_operation | mfem::Mesh | protected |
| 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::Mesh | protected |
| LocalRefinement(const Array< int > &marked_el, int type=3) | mfem::Mesh | protectedvirtual |
| Make1D(int n, double sx=1.0) | mfem::Mesh | protected |
| Make2D(int nx, int ny, Element::Type type, int generate_edges, double sx, double sy) | mfem::Mesh | protected |
| Make3D(int nx, int ny, int nz, Element::Type type, int generate_edges, double sx, double sy, double sz) | mfem::Mesh | protected |
| MarkForRefinement() | mfem::Mesh | protected |
| MarkTetMeshForRefinement() | mfem::Mesh | protected |
| MarkTriMeshForRefinement() | mfem::Mesh | protected |
| Mesh(const NCMesh &ncmesh) | mfem::Mesh | protected |
| Mesh() | mfem::Mesh | inline |
| Mesh(const Mesh &mesh, bool copy_nodes=true) | mfem::Mesh | explicit |
| Mesh(int _Dim, int NVert, int NElem, int NBdrElem=0, int _spaceDim=-1) | mfem::Mesh | inline |
| 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::Mesh | inline |
| Mesh(int nx, int ny, Element::Type type, int generate_edges=0, double sx=1.0, double sy=1.0) | mfem::Mesh | inline |
| Mesh(int n, double sx=1.0) | mfem::Mesh | inlineexplicit |
| Mesh(const char *filename, int generate_edges=0, int refine=1, bool fix_orientation=true) | mfem::Mesh | |
| 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 | |
| meshgen | mfem::Mesh | protected |
| MeshGenerator() | mfem::Mesh | inline |
| MesquiteSmooth(const int mesquite_option=0) | mfem::Mesh | |
| MoveNodes(const Vector &displacements) | mfem::Mesh | |
| MoveVertices(const Vector &displacements) | mfem::Mesh | |
| nc_faces_info | mfem::Mesh | protected |
| ncmesh | mfem::Mesh | |
| NewElement(int geom) | mfem::Mesh | |
| NewNodes(GridFunction &nodes, bool make_owner=false) | mfem::Mesh | |
| Nodes | mfem::Mesh | protected |
| Nonconforming() const | mfem::Mesh | inline |
| NonconformingDerefinement(Array< double > &elem_error, double threshold, int nc_limit=0, int op=1) | mfem::Mesh | protectedvirtual |
| NonconformingRefinement(const Array< Refinement > &refinements, int nc_limit=0) | mfem::Mesh | protectedvirtual |
| NONE enum value | mfem::Mesh | |
| NumOfBdrElements | mfem::Mesh | protected |
| NumOfEdges | mfem::Mesh | protected |
| NumOfElements | mfem::Mesh | protected |
| NumOfFaces | mfem::Mesh | protected |
| NumOfVertices | mfem::Mesh | protected |
| NURBSext | mfem::Mesh | |
| NURBSExtension class | mfem::Mesh | friend |
| NURBSUniformRefinement() | mfem::Mesh | protectedvirtual |
| Operation enum name | mfem::Mesh | |
| own_nodes | mfem::Mesh | protected |
| ParMesh class | mfem::Mesh | friend |
| ParNCMesh class | mfem::Mesh | friend |
| PrepareNodeReorder(DSTable **old_v_to_v, Table **old_elem_vert) | mfem::Mesh | protected |
| Print(std::ostream &out=std::cout) const | mfem::Mesh | virtual |
| PrintCharacteristics(Vector *Vh=NULL, Vector *Vk=NULL, std::ostream &out=std::cout) | mfem::Mesh | |
| PrintElement(const Element *, std::ostream &) | mfem::Mesh | protectedstatic |
| PrintElementsWithPartitioning(int *partitioning, std::ostream &out, int interior_faces=0) | mfem::Mesh | |
| PrintElementWithoutAttr(const Element *, std::ostream &) | mfem::Mesh | protectedstatic |
| PrintInfo(std::ostream &out=std::cout) | mfem::Mesh | inlinevirtual |
| PrintSurfaces(const Table &Aface_face, std::ostream &out) const | mfem::Mesh | |
| PrintTopo(std::ostream &out, const Array< int > &e_to_k) const | mfem::Mesh | protected |
| 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::Mesh | virtual |
| quad_t typedef | mfem::Mesh | |
| QuadUniformRefinement() | mfem::Mesh | protectedvirtual |
| RandomRefinement(double prob, bool aniso=false, int nonconforming=-1, int nc_limit=0) | mfem::Mesh | |
| ReadCubit(named_ifstream &input, int &curved, int &read_gf) | mfem::Mesh | protected |
| ReadElement(std::istream &) | mfem::Mesh | protected |
| ReadElementWithoutAttr(std::istream &) | mfem::Mesh | protected |
| ReadGmshMesh(std::istream &input) | mfem::Mesh | protected |
| ReadInlineMesh(std::istream &input, int generate_edges=0) | mfem::Mesh | protected |
| ReadLineMesh(std::istream &input) | mfem::Mesh | protected |
| ReadMFEMMesh(std::istream &input, bool mfem_v11, int &curved) | mfem::Mesh | protected |
| ReadNetgen2DMesh(std::istream &input, int &curved) | mfem::Mesh | protected |
| ReadNetgen3DMesh(std::istream &input) | mfem::Mesh | protected |
| ReadNURBSMesh(std::istream &input, int &curved, int &read_gf) | mfem::Mesh | protected |
| ReadTrueGridMesh(std::istream &input) | mfem::Mesh | protected |
| ReadVTKMesh(std::istream &input, int &curved, int &read_gf) | mfem::Mesh | protected |
| REBALANCE enum value | mfem::Mesh | |
| RedRefinement(int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle) | mfem::Mesh | inlineprotected |
| ReduceInt(int value) const | mfem::Mesh | inlinevirtual |
| REFINE enum value | mfem::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 | |
| RemoveInternalBoundaries() | mfem::Mesh | |
| RemoveUnusedVertices() | mfem::Mesh | |
| ReorderElements(const Array< int > &ordering, bool reorder_vertices=true) | mfem::Mesh | |
| ReorientTetMesh() | mfem::Mesh | virtual |
| Rotate3(int &, int &, int &) | mfem::Mesh | inlineprotectedstatic |
| ScaleElements(double sf) | mfem::Mesh | |
| ScaleSubdomains(double sf) | mfem::Mesh | |
| seg_t typedef | mfem::Mesh | |
| sequence | mfem::Mesh | protected |
| SetAttributes() | mfem::Mesh | |
| SetCurvature(int order, bool discont=false, int space_dim=-1, int ordering=1) | mfem::Mesh | |
| SetMeshGen() | mfem::Mesh | protected |
| 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 | |
| SetVertices(const Vector &vert_coord) | mfem::Mesh | |
| ShiftL2R(int &, int &, int &) | mfem::Mesh | inlineprotectedstatic |
| skip_comment_lines(std::istream &is, const char comment_char) | mfem::Mesh | inlineprotectedstatic |
| spaceDim | mfem::Mesh | protected |
| SpaceDimension() const | mfem::Mesh | inline |
| Swap(Mesh &other, bool non_geometry=false) | mfem::Mesh | protected |
| SwapNodes(GridFunction *&nodes, int &own_nodes_) | mfem::Mesh | |
| tet_t typedef | mfem::Mesh | |
| TetMemory | mfem::Mesh | protected |
| Tetrahedron class | mfem::Mesh | friend |
| Transform(void(*f)(const Vector &, Vector &)) | mfem::Mesh | |
| Transform(VectorCoefficient &deformation) | mfem::Mesh | |
| Transformation | mfem::Mesh | protected |
| Transformation2 | mfem::Mesh | protected |
| tri_t typedef | mfem::Mesh | |
| UniformRefinement(int i, const DSTable &, int *, int *, int *) | mfem::Mesh | protected |
| UniformRefinement() | mfem::Mesh | |
| UpdateNodes() | mfem::Mesh | protected |
| UpdateNURBS() | mfem::Mesh | protected |
| vertices | mfem::Mesh | protected |
| vtk_quadratic_hex | mfem::Mesh | protectedstatic |
| vtk_quadratic_tet | mfem::Mesh | protectedstatic |
| ~Mesh() | mfem::Mesh | virtual |
1.8.5