![]() |
MFEM v4.8.0
Finite element discretization library
|
This is the complete list of members for mfem::ParPumiMesh, including all inherited members.
| AddBdrElement(Element *elem) | mfem::Mesh | |
| AddBdrElements(Array< Element * > &bdr_elems, const Array< int > &be_to_face) | mfem::Mesh | |
| AddBdrPoint(int v, int attr=1) | mfem::Mesh | |
| AddBdrQuad(int v1, int v2, int v3, int v4, int attr=1) | mfem::Mesh | |
| AddBdrQuad(const int *vi, int attr=1) | mfem::Mesh | |
| AddBdrQuadAsTriangles(const int *vi, int attr=1) | mfem::Mesh | |
| AddBdrSegment(int v1, int v2, int attr=1) | mfem::Mesh | |
| AddBdrSegment(const int *vi, int attr=1) | mfem::Mesh | |
| AddBdrTriangle(int v1, int v2, int v3, int attr=1) | mfem::Mesh | |
| AddBdrTriangle(const int *vi, int attr=1) | mfem::Mesh | |
| AddElement(Element *elem) | mfem::Mesh | |
| AddHex(int v1, int v2, int v3, int v4, int v5, int v6, int v7, int v8, int attr=1) | mfem::Mesh | |
| AddHex(const int *vi, int attr=1) | mfem::Mesh | |
| AddHexAs24TetsWithPoints(int *vi, std::map< std::array< int, 4 >, int > &hex_face_verts, int attr=1) | mfem::Mesh | |
| AddHexAsPyramids(const int *vi, int attr=1) | mfem::Mesh | |
| AddHexAsTets(const int *vi, int attr=1) | mfem::Mesh | |
| AddHexAsWedges(const int *vi, int attr=1) | mfem::Mesh | |
| AddPointFaceElement(int lf, int gf, int el) | mfem::Mesh | protected |
| AddPyramid(int v1, int v2, int v3, int v4, int v5, int attr=1) | mfem::Mesh | |
| AddPyramid(const int *vi, int attr=1) | mfem::Mesh | |
| AddQuad(int v1, int v2, int v3, int v4, int attr=1) | mfem::Mesh | |
| AddQuad(const int *vi, int attr=1) | mfem::Mesh | |
| AddQuadAs4TrisWithPoints(int *vi, int attr=1) | mfem::Mesh | |
| AddQuadAs5QuadsWithPoints(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 |
| AddSegment(int v1, int v2, int attr=1) | mfem::Mesh | |
| AddSegment(const int *vi, int attr=1) | mfem::Mesh | |
| AddSegmentFaceElement(int lf, int gf, int el, int v0, int v1) | mfem::Mesh | protected |
| AddTet(int v1, int v2, int v3, int v4, int attr=1) | mfem::Mesh | |
| AddTet(const int *vi, int attr=1) | mfem::Mesh | |
| AddTri(const int *vi, int attr=1) | mfem::Mesh | inline |
| AddTriangle(int v1, int v2, int v3, 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 |
| AddTriFaces(const Array< int > &v, const std::unique_ptr< STable3D > &faces, const std::unique_ptr< STable3D > &shared_faces, int elem, int start, int end, const int fverts[][N]) | mfem::ParMesh | protected |
| AddVertex(real_t x, real_t y=0.0, real_t z=0.0) | mfem::Mesh | |
| AddVertex(const real_t *coords) | mfem::Mesh | |
| AddVertex(const Vector &coords) | mfem::Mesh | |
| AddVertexAtMeanCenter(const int *vi, const int nverts, int dim=3) | mfem::Mesh | |
| AddVertexParents(int i, int p1, int p2) | mfem::Mesh | |
| AddWedge(int v1, int v2, int v3, int v4, int v5, int v6, int attr=1) | mfem::Mesh | |
| AddWedge(const int *vi, int attr=1) | mfem::Mesh | |
| AggregateError(const Array< real_t > &elem_error, const int *fine, int nfine, int op) | mfem::Mesh | protected |
| ApplyLocalSlaveTransformation(FaceElementTransformations &FT, const FaceInfo &fi, bool is_ghost) const | mfem::Mesh | protected |
| attribute_sets | mfem::Mesh | |
| attributes | mfem::Mesh | |
| AverageVertices(const int *indexes, int n, int result) | mfem::Mesh | protected |
| bdr_attribute_sets | mfem::Mesh | |
| bdr_attributes | mfem::Mesh | |
| BdrBisection(int i, const HashTable< Hashed2 > &) | mfem::Mesh | protected |
| BdrTransformation | 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, HashTable< Hashed2 > &) | mfem::Mesh | protected |
| boundary | mfem::Mesh | protected |
| BuildCubitBoundaries(const cubit::CubitBlock *blocks, const std::vector< int > &boundary_ids, const std::map< int, std::vector< int > > &element_ids_for_boundary_id, const std::map< int, std::vector< std::vector< int > > > &node_ids_for_boundary_id, const std::map< int, std::vector< int > > &side_ids_for_boundary_id, const std::map< int, int > &block_id_for_element_id, const std::map< int, int > &cubit_to_mfem_vertex_map) | mfem::Mesh | protected |
| BuildCubitElements(const int num_elements, const cubit::CubitBlock *blocks, const std::vector< int > &block_ids, const std::map< int, std::vector< int > > &element_ids_for_block_id, const std::map< int, std::vector< int > > &node_ids_for_element_id, const std::map< int, int > &cubit_to_mfem_vertex_map) | mfem::Mesh | protected |
| BuildCubitVertices(const std::vector< int > &unique_vertex_ids, const std::vector< double > &coordx, const std::vector< double > &coordy, const std::vector< double > &coordz) | mfem::Mesh | protected |
| BuildEdgeGroup(int ngroups, const Table &edge_element) | mfem::ParMesh | protected |
| BuildFaceGroup(int ngroups, const Mesh &mesh, const Array< int > &face_group, int &nstria, int &nsquad) | mfem::ParMesh | protected |
| BuildFaceNbrElementToFaceTable() | mfem::ParMesh | protected |
| BuildLocalBoundary(const Mesh &global_mesh, const int *partitioning, const Array< int > &vert_global_local, Array< bool > &activeBdrElem, Table *&edge_element) | mfem::ParMesh | protected |
| BuildLocalElements(const Mesh &global_mesh, const int *partitioning, const Array< int > &vert_global_local) | mfem::ParMesh | protected |
| BuildLocalVertices(const Mesh &global_mesh, const int *partitioning, Array< int > &vert_global_local) | mfem::ParMesh | protected |
| BuildSharedEdgeElems(int nedges, Mesh &mesh, const Array< int > &vert_global_local, const Table *edge_element) | mfem::ParMesh | protected |
| BuildSharedFaceElems(int ntri_faces, int nquad_faces, const Mesh &mesh, const int *partitioning, const STable3D *faces_tbl, const Array< int > &face_group, const Array< int > &vert_global_local) | mfem::ParMesh | protected |
| BuildSharedVertMapping(int nvert, const Table *vert_element, const Array< int > &vert_global_local) | mfem::ParMesh | protected |
| BuildVertexGroup(int ngroups, const Table &vert_element) | mfem::ParMesh | protected |
| CartesianPartitioning(int nxyz[]) | mfem::Mesh | |
| ChangeVertexDataOwnership(real_t *vertices, int len_vertices, bool zerocopy=false) | mfem::Mesh | |
| CheckBdrElementOrientation(bool fix_it=true) | mfem::Mesh | |
| CheckDisplacements(const Vector &displacements, real_t &tmax) | mfem::Mesh | |
| CheckElementOrientation(bool fix_it=true) | mfem::Mesh | |
| CheckPartitioning(int *partitioning_) | mfem::Mesh | |
| Clear() | mfem::Mesh | inline |
| CoarseFineTr | mfem::Mesh | mutableprotected |
| ComposeQuadOrientations(int ori_a_b, int ori_b_c) | mfem::Mesh | protectedstatic |
| ComposeTriOrientations(int ori_a_b, int ori_b_c) | mfem::Mesh | protectedstatic |
| ComputeGlobalElementOffset() const | mfem::ParMesh | protected |
| Conforming() const | mfem::Mesh | inline |
| CreatePeriodicVertexMapping(const std::vector< Vector > &translations, real_t tol=1e-8) const | mfem::Mesh | |
| CreateVTKMesh(const Vector &points, const Array< int > &cell_data, const Array< int > &cell_offsets, const Array< int > &cell_types, const Array< int > &cell_attributes, int &curved, int &read_gf, bool &finalize_topo) | mfem::Mesh | protected |
| DebugDump(std::ostream &os) const | mfem::Mesh | |
| DecodeFaceInfoLocalIndex(int info) | mfem::Mesh | inlinestatic |
| DecodeFaceInfoOrientation(int info) | mfem::Mesh | inlinestatic |
| DecodeFaceSplittings(HashTable< Hashed2 > &v_to_v, const int *v, const Array< unsigned > &codes, int &pos) | mfem::ParMesh | protected |
| DegreeElevate(int rel_degree, int degree=16) | mfem::Mesh | |
| DeleteBoundaryElementToEdge() | mfem::Mesh | inline |
| DeleteFaceNbrData() | mfem::ParMesh | protected |
| DeleteGeometricFactors() | mfem::Mesh | |
| DeleteTables() | mfem::Mesh | inlineprotected |
| DEREFINE enum value | mfem::Mesh | |
| DerefineByError(Array< real_t > &elem_error, real_t threshold, int nc_limit=0, int op=1) | mfem::Mesh | |
| DerefineByError(const Vector &elem_error, real_t threshold, int nc_limit=0, int op=1) | mfem::Mesh | |
| Destroy() | mfem::ParMesh | protected |
| DestroyPointers() | mfem::Mesh | protected |
| DestroyTables() | mfem::Mesh | protected |
| Dim | mfem::Mesh | protected |
| Dimension() const | mfem::Mesh | inline |
| DistributeAttributes(Array< int > &attr) | mfem::ParMesh | protected |
| 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 |
| ElementConformity enum name | mfem::Mesh | |
| ElementLocation enum name | mfem::Mesh | |
| elements | mfem::Mesh | protected |
| ElementToEdgeTable() const | mfem::Mesh | |
| ElementToElementTable() | mfem::Mesh | |
| ElementToFaceTable() const | mfem::Mesh | |
| EncodeFaceInfo(int local_face_index, int orientation) | mfem::Mesh | inlinestatic |
| EnsureNCMesh(bool simplices_nonconforming=false) | mfem::Mesh | |
| EnsureNodes() | mfem::Mesh | |
| EnsureParNodes() | mfem::ParMesh | protected |
| EulerNumber() const | mfem::Mesh | inline |
| EulerNumber2D() const | mfem::Mesh | inline |
| ExchangeFaceNbrData(Table *gr_sface, int *s2l_face) | mfem::ParMesh | protected |
| ExchangeFaceNbrData() | mfem::ParMesh | |
| ExchangeFaceNbrNodes() | mfem::ParMesh | |
| face_edge | mfem::Mesh | mutableprotected |
| face_geom_factors | mfem::Mesh | |
| face_nbr_el_ori | mfem::ParMesh | protected |
| face_nbr_el_to_face | mfem::ParMesh | protected |
| face_nbr_elements | mfem::ParMesh | |
| face_nbr_elements_offset | mfem::ParMesh | |
| face_nbr_group | mfem::ParMesh | |
| face_nbr_vertices | mfem::ParMesh | |
| face_nbr_vertices_offset | mfem::ParMesh | |
| face_to_elem | mfem::Mesh | mutableprotected |
| FaceElemTr | mfem::Mesh | protected |
| FaceInfoTag enum name | mfem::Mesh | |
| FaceIsInterior(int FaceNo) const | mfem::Mesh | inline |
| FaceIsTrueInterior(int FaceNo) const | mfem::ParMesh | inline |
| faces | mfem::Mesh | protected |
| faces_info | mfem::Mesh | protected |
| FaceTopology enum name | mfem::Mesh | |
| FaceTransformation | mfem::Mesh | protected |
| FieldMFEMtoPUMI(apf::Mesh2 *apf_mesh, ParGridFunction *grid_vel, ParGridFunction *grid_pr, apf::Field *vel_field, apf::Field *pr_field, apf::Field *vel_mag_field) | mfem::ParPumiMesh | |
| FieldMFEMtoPUMI(apf::Mesh2 *apf_mesh, ParGridFunction *grid_pr, apf::Field *pr_field, apf::Field *pr_mag_field) | mfem::ParPumiMesh | |
| FieldPUMItoMFEM(apf::Mesh2 *apf_mesh, apf::Field *field, ParGridFunction *grid) | mfem::ParPumiMesh | |
| Finalize(bool refine=false, bool fix_orientation=false) override | mfem::ParMesh | virtual |
| FinalizeCheck() | mfem::Mesh | protected |
| FinalizeHexMesh(int generate_edges=0, int refine=0, bool fix_orientation=true) | mfem::Mesh | |
| FinalizeMesh(int refine=0, bool fix_orientation=true) | mfem::Mesh | |
| FinalizeParTopo() | mfem::ParMesh | protected |
| 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(bool generate_bdr=true) | mfem::Mesh | |
| FinalizeTriMesh(int generate_edges=0, int refine=0, bool fix_orientation=true) | mfem::Mesh | |
| FinalizeWedgeMesh(int generate_edges=0, int refine=0, bool fix_orientation=true) | mfem::Mesh | |
| FindCoarseElement(int i) | mfem::Mesh | protected |
| FindFaceNeighbors(const int elem) const | mfem::Mesh | |
| FindPoints(DenseMatrix &point_mat, Array< int > &elem_ids, Array< IntegrationPoint > &ips, bool warn=true, InverseElementTransformation *inv_trans=NULL) override | mfem::ParMesh | virtual |
| FindSharedEdges(const Mesh &mesh, const int *partition, Table *&edge_element, ListOfIntegerSets &groups) | mfem::ParMesh | protected |
| FindSharedFaces(const Mesh &mesh, const int *partition, Array< int > &face_group, ListOfIntegerSets &groups) | mfem::ParMesh | protected |
| FindSharedVertices(const int *partition, Table *vertex_element, ListOfIntegerSets &groups) | mfem::ParMesh | 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() override | mfem::ParMesh | inlinevirtual |
| GenerateFaces() | mfem::Mesh | protected |
| GenerateNCFaceInfo() | mfem::Mesh | protected |
| GenerateOffsets(int N, HYPRE_BigInt loc_sizes[], Array< HYPRE_BigInt > *offsets[]) const | mfem::ParMesh | |
| GeneratePartitioning(int nparts, int part_method=1) | mfem::Mesh | |
| geom_factors | 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 | |
| GetBdrElementAdjacentElement2(int bdr_el, int &el, int &info) const | mfem::Mesh | |
| GetBdrElementBaseGeometry(int i) const | mfem::Mesh | inline |
| GetBdrElementData(int geom, Array< int > &bdr_elem_vtx, Array< int > &bdr_attr) const | mfem::Mesh | inline |
| GetBdrElementEdgeIndex(int i) const | mfem::Mesh | inline |
| GetBdrElementEdges(int i, Array< int > &edges, Array< int > &cor) const | mfem::Mesh | |
| GetBdrElementFace(int i, int *f, int *o) const | mfem::Mesh | |
| GetBdrElementFaceIndex(int be_idx) const | mfem::Mesh | inline |
| GetBdrElementGeometry(int i) const | mfem::Mesh | inline |
| GetBdrElementTransformation(int i) | mfem::Mesh | |
| GetBdrElementTransformation(int i, IsoparametricTransformation *ElTr) const | mfem::Mesh | |
| GetBdrElementType(int i) const | mfem::Mesh | |
| GetBdrElementVertices(int i, Array< int > &v) const | mfem::Mesh | inline |
| GetBdrFace(int i) const | mfem::Mesh | inline |
| GetBdrFaceTransformations(int BdrElemNo) | mfem::Mesh | |
| GetBdrFaceTransformations(int BdrElemNo, FaceElementTransformations &FElTr, IsoparametricTransformation &ElTr1, IsoparametricTransformation &ElTr2) const | mfem::Mesh | |
| GetBdrPointMatrix(int i, DenseMatrix &pointmat) const | mfem::Mesh | |
| GetBoundingBox(Vector &p_min, Vector &p_max, int ref=2) | mfem::ParMesh | |
| GetCharacteristics(real_t &h_min, real_t &h_max, real_t &kappa_min, real_t &kappa_max) | mfem::ParMesh | |
| mfem::Mesh::GetCharacteristics(real_t &h_min, real_t &h_max, real_t &kappa_min, real_t &kappa_max, Vector *Vh=NULL, Vector *Vk=NULL) | mfem::Mesh | |
| GetComm() const | mfem::ParMesh | inline |
| GetEdgeOrdering(const DSTable &v_to_v, Array< int > &order) | mfem::Mesh | protected |
| GetEdgeSplittings(Element *edge, const DSTable &v_to_v, int *middle) | mfem::ParMesh | protected |
| GetEdgeTransformation(int i, IsoparametricTransformation *EdTr) const | 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) const | mfem::Mesh | inline |
| GetElementCenter(int i, Vector ¢er) | mfem::Mesh | |
| 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::Mesh | protected |
| GetElementData(int geom, Array< int > &elem_vtx, Array< int > &attr) const | mfem::Mesh | inline |
| GetElementEdges(int i, Array< int > &edges, Array< int > &cor) const | mfem::Mesh | |
| GetElementFaces(int i, Array< int > &faces, Array< int > &ori) const | mfem::Mesh | |
| GetElementGeometry(int i) const | mfem::Mesh | inline |
| GetElementJacobian(int i, DenseMatrix &J, const IntegrationPoint *ip=NULL) | mfem::Mesh | |
| GetElementsArray() const | mfem::Mesh | inline |
| GetElementSize(int i, int type=0) | mfem::Mesh | |
| GetElementSize(int i, const Vector &dir) | mfem::Mesh | |
| GetElementSize(ElementTransformation *T, int type=0) const | mfem::Mesh | |
| GetElementToEdgeTable(Table &) | mfem::Mesh | protected |
| GetElementToFaceTable(int ret_ftbl=0) | mfem::Mesh | protected |
| GetElementTransformation(int i, IsoparametricTransformation *ElTr) const | mfem::Mesh | |
| GetElementTransformation(int i) | mfem::Mesh | |
| GetElementTransformation(int i, const Vector &nodes, IsoparametricTransformation *ElTr) const | mfem::Mesh | |
| GetElementType(int i) const | mfem::Mesh | |
| GetElementVertices(int i, Array< int > &v) const | mfem::Mesh | inline |
| GetElementVolume(int i) | mfem::Mesh | |
| GetExteriorFaceMarker(Array< int > &face_marker) const override | mfem::ParMesh | virtual |
| GetFace(int i) const | mfem::Mesh | inline |
| GetFaceBaseGeometry(int i) const | mfem::Mesh | inline |
| GetFaceEdges(int i, Array< int > &edges, Array< int > &o) const | mfem::Mesh | |
| GetFaceEdgeTable() const | mfem::Mesh | |
| GetFaceElements(int Face, int *Elem1, int *Elem2) const | mfem::Mesh | |
| GetFaceElementTransformations(int FaceNo, int mask=31) override | mfem::ParMesh | virtual |
| GetFaceElementTransformations(int FaceNo, FaceElementTransformations &FElTr, IsoparametricTransformation &ElTr1, IsoparametricTransformation &ElTr2, int mask=31) const override | mfem::ParMesh | virtual |
| GetFaceElementType(int Face) const | mfem::Mesh | |
| GetFaceGeometricFactors(const IntegrationRule &ir, const int flags, FaceType type, MemoryType d_mt=MemoryType::DEFAULT) | mfem::Mesh | |
| GetFaceGeometry(int i) const | mfem::Mesh | |
| GetFaceGeometryType(int Face) const | mfem::Mesh | inline |
| GetFaceInformation(int f) const | mfem::Mesh | |
| GetFaceInfos(int Face, int *Inf1, int *Inf2) const | mfem::Mesh | |
| GetFaceInfos(int Face, int *Inf1, int *Inf2, int *NCFace) const | mfem::Mesh | |
| GetFaceNbrElementFaces(int i, Array< int > &faces, Array< int > &orientation) const | mfem::ParMesh | |
| GetFaceNbrElementSize(int i, int type=0) | mfem::ParMesh | |
| GetFaceNbrElementTransformation(int FaceNo) | mfem::ParMesh | |
| GetFaceNbrElementTransformation(int FaceNo, IsoparametricTransformation &ElTr) const | mfem::ParMesh | |
| GetFaceNbrGroup(int fn) const | mfem::ParMesh | inline |
| GetFaceNbrRank(int fn) const | mfem::ParMesh | |
| GetFaceSplittings(const int *fv, const HashTable< Hashed2 > &v_to_v, Array< unsigned > &codes) | mfem::ParMesh | protected |
| GetFacesTable() | mfem::Mesh | protected |
| GetFaceToAllElementTable() const | mfem::ParMesh | |
| GetFaceToBdrElMap() const | mfem::Mesh | |
| GetFaceToElementTable() const | mfem::Mesh | |
| GetFaceTransformation(int FaceNo) | mfem::Mesh | |
| GetFaceTransformation(int i, IsoparametricTransformation *FTr) const | mfem::Mesh | |
| GetFaceVertices(int i, Array< int > &vert) const | mfem::Mesh | inline |
| GetGeckoElementOrdering(Array< int > &ordering, int iterations=4, int window=4, int period=2, int seed=0, bool verbose=false, real_t time_limit=0) | mfem::Mesh | |
| GetGeometricFactors(const IntegrationRule &ir, const int flags, MemoryType d_mt=MemoryType::DEFAULT) | mfem::Mesh | |
| GetGeometricParametersFromJacobian(const DenseMatrix &J, real_t &volume, Vector &aspr, Vector &skew, Vector &ori) const | mfem::Mesh | |
| GetGeometries(int dim, Array< Geometry::Type > &el_geoms) const | mfem::Mesh | |
| GetGhostFaceTransformation(FaceElementTransformations &FElTr, Element::Type face_type, Geometry::Type face_geom) const | mfem::ParMesh | protected |
| GetGhostFaceTransformation(FaceElementTransformations *FElTr, Element::Type face_type, Geometry::Type face_geom) const | mfem::ParMesh | inlineprotected |
| GetGlobalEdgeIndices(Array< HYPRE_BigInt > &gi) const | mfem::ParMesh | |
| GetGlobalElementIndices(Array< HYPRE_BigInt > &gi) const | mfem::ParMesh | |
| GetGlobalElementNum(int local_element_num) const | mfem::ParMesh | |
| GetGlobalFaceIndices(Array< HYPRE_BigInt > &gi) const | mfem::ParMesh | |
| GetGlobalNE() const | mfem::Mesh | inline |
| GetGlobalVertexIndices(Array< HYPRE_BigInt > &gi) const | mfem::ParMesh | |
| GetHilbertElementOrdering(Array< int > &ordering) | mfem::Mesh | |
| GetInteriorFaceTransformations(int FaceNo) | mfem::Mesh | |
| GetInteriorFaceTransformations(int FaceNo, FaceElementTransformations &FElTr, IsoparametricTransformation &ElTr1, IsoparametricTransformation &ElTr2) const | mfem::Mesh | |
| GetLastOperation() const | mfem::Mesh | inline |
| GetLength(int i, int j) const | mfem::Mesh | protected |
| GetLocalElementNum(long long global_element_num) const | mfem::ParMesh | |
| GetLocalFaceTransformation(int face_type, int elem_type, IsoparametricTransformation &Transf, int info) const | mfem::Mesh | |
| GetLocalPtToSegTransformation(IsoparametricTransformation &, int i) const | mfem::Mesh | protected |
| GetLocalQuadToHexTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetLocalQuadToPyrTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetLocalQuadToWdgTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetLocalSegToQuadTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetLocalSegToTriTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetLocalTriToPyrTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetLocalTriToTetTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetLocalTriToWdgTransformation(IsoparametricTransformation &loc, int i) const | mfem::Mesh | protected |
| GetMyRank() const | mfem::ParMesh | inline |
| GetNBE() const | mfem::Mesh | inline |
| GetNE() const | mfem::Mesh | inline |
| GetNEdges() const | mfem::Mesh | inline |
| GetNFaceNeighborElements() const | mfem::ParMesh | inline |
| GetNFaceNeighbors() const | mfem::ParMesh | inline |
| GetNFaces() const | mfem::Mesh | inline |
| GetNFbyType(FaceType type) const override | mfem::ParMesh | virtual |
| GetNGroups() const | mfem::ParMesh | inline |
| GetNodalFESpace() const | mfem::Mesh | |
| GetNode(int i, real_t *coord) const | mfem::Mesh | |
| GetNodes(Vector &node_coord) const | mfem::Mesh | |
| GetNodes() | mfem::Mesh | inline |
| GetNodes() const | mfem::Mesh | inline |
| GetNodes(GridFunction &nodes) const | mfem::Mesh | |
| GetNodesSequence() const | mfem::Mesh | inline |
| GetNRanks() const | mfem::ParMesh | inline |
| GetNSharedFaces() const | mfem::ParMesh | |
| GetNumFaces() const | mfem::Mesh | |
| GetNumFacesWithGhost() const | mfem::Mesh | |
| GetNumGeometries(int dim) const | mfem::Mesh | |
| GetNV() const | mfem::Mesh | inline |
| GetPatchAttribute(int i) const | mfem::Mesh | |
| GetPatchBdrAttribute(int i) const | mfem::Mesh | |
| GetPointMatrix(int i, DenseMatrix &pointmat) const | mfem::Mesh | |
| GetQuadOrientation(const int *base, const int *test) | mfem::Mesh | protectedstatic |
| GetRefinementTransforms() const | mfem::Mesh | |
| GetSequence() const | mfem::Mesh | inline |
| GetSerialMesh(int save_rank) const | mfem::ParMesh | |
| GetSharedEdgeCommunicator(int ordering, GroupCommunicator &sedge_comm) const | mfem::ParMesh | protected |
| GetSharedEdgeCommunicator(GroupCommunicator &sedge_comm) const | mfem::ParMesh | inline |
| GetSharedFace(int sface) const | mfem::ParMesh | |
| GetSharedFacesTable() | mfem::ParMesh | protected |
| GetSharedFaceTransformations(int sf, bool fill2=true) | mfem::ParMesh | |
| GetSharedFaceTransformations(int sf, FaceElementTransformations &FElTr, IsoparametricTransformation &ElTr1, IsoparametricTransformation &ElTr2, bool fill2=true) const | mfem::ParMesh | |
| GetSharedFaceTransformationsByLocalIndex(int FaceNo, bool fill2=true) | mfem::ParMesh | |
| GetSharedFaceTransformationsByLocalIndex(int FaceNo, FaceElementTransformations &FElTr, IsoparametricTransformation &ElTr1, IsoparametricTransformation &ElTr2, bool fill2=true) const | mfem::ParMesh | |
| GetSharedQuadCommunicator(int ordering, GroupCommunicator &squad_comm) const | mfem::ParMesh | protected |
| GetSharedQuadCommunicator(GroupCommunicator &squad_comm) const | mfem::ParMesh | inline |
| GetSharedTriCommunicator(int ordering, GroupCommunicator &stria_comm) const | mfem::ParMesh | protected |
| GetSharedTriCommunicator(GroupCommunicator &stria_comm) const | mfem::ParMesh | inline |
| GetSharedVertexCommunicator(int ordering, GroupCommunicator &svert_comm) const | mfem::ParMesh | protected |
| GetSharedVertexCommunicator(GroupCommunicator &svert_comm) const | mfem::ParMesh | inline |
| GetTetOrientation(const int *base, const int *test) | mfem::Mesh | protectedstatic |
| GetTransformationFEforElementType(Element::Type) | mfem::Mesh | static |
| GetTriOrientation(const int *base, const int *test) | mfem::Mesh | protectedstatic |
| GetTypicalElementGeometry() const | mfem::Mesh | |
| GetTypicalElementTransformation() | mfem::Mesh | |
| GetTypicalFaceGeometry() const | mfem::Mesh | |
| GetVertex(int i) const | mfem::Mesh | inline |
| GetVertex(int i) | mfem::Mesh | inline |
| GetVertexToBdrElementTable() | mfem::Mesh | |
| GetVertexToElementTable() | mfem::Mesh | |
| GetVertexToVertexTable(DSTable &) const | mfem::Mesh | |
| GetVertices(Vector &vert_coord) const | mfem::Mesh | |
| glob_elem_offset | mfem::ParMesh | mutableprotected |
| glob_offset_sequence | mfem::ParMesh | mutableprotected |
| GreenRefinement(int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle) | mfem::Mesh | inlineprotected |
| group_sedge | mfem::ParMesh | protected |
| group_squad | mfem::ParMesh | protected |
| group_stria | mfem::ParMesh | protected |
| group_svert | mfem::ParMesh | protected |
| GroupEdge(int group, int i, int &edge, int &o) const | mfem::ParMesh | |
| GroupEdge(int group, int i) const | mfem::ParMesh | inline |
| GroupNEdges(int group) const | mfem::ParMesh | inline |
| GroupNQuadrilaterals(int group) const | mfem::ParMesh | inline |
| GroupNTriangles(int group) const | mfem::ParMesh | inline |
| GroupNVertices(int group) const | mfem::ParMesh | inline |
| GroupQuadrilateral(int group, int i, int &face, int &o) const | mfem::ParMesh | |
| GroupQuadrilateral(int group, int i) const | mfem::ParMesh | inline |
| GroupTriangle(int group, int i, int &face, int &o) const | mfem::ParMesh | |
| GroupTriangle(int group, int i) const | mfem::ParMesh | inline |
| GroupVertex(int group, int i) const | mfem::ParMesh | inline |
| gtopo | mfem::ParMesh | |
| HasBoundaryElements() const override | mfem::ParMesh | virtual |
| HasGeometry(Geometry::Type geom) const | mfem::Mesh | inline |
| have_face_nbr_data | mfem::ParMesh | |
| hex_t typedef | mfem::Mesh | |
| Init() | 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 |
| InvertQuadOrientation(int ori) | mfem::Mesh | protectedstatic |
| InvertTriOrientation(int ori) | mfem::Mesh | protectedstatic |
| IsSlaveFace(const FaceInfo &fi) const | mfem::Mesh | protected |
| KnotInsert(Array< KnotVector * > &kv) | mfem::Mesh | |
| KnotInsert(Array< Vector * > &kv) | mfem::Mesh | |
| KnotRemove(Array< Vector * > &kv) | mfem::Mesh | |
| last_operation | mfem::Mesh | protected |
| Load(std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true) override | mfem::ParMesh | virtual |
| Loader(std::istream &input, int generate_edges=0, std::string parse_tag="") | mfem::Mesh | protected |
| LoadFromFile(const std::string &filename, int generate_edges=0, int refine=1, bool fix_orientation=true) | mfem::Mesh | static |
| LoadPatchTopo(std::istream &input, Array< int > &edge_to_knot) | mfem::Mesh | protected |
| LoadSharedEntities(std::istream &input) | mfem::ParMesh | protected |
| LocalRefinement(const Array< int > &marked_el, int type=3) override | mfem::ParMesh | protectedvirtual |
| Make1D(int n, real_t sx=1.0) | mfem::Mesh | protected |
| Make2D(int nx, int ny, Element::Type type, real_t sx, real_t sy, bool generate_edges, bool sfc_ordering) | mfem::Mesh | protected |
| Make2D4TrisFromQuad(int nx, int ny, real_t sx, real_t sy) | mfem::Mesh | protected |
| Make2D5QuadsFromQuad(int nx, int ny, real_t sx, real_t sy) | mfem::Mesh | protected |
| Make3D(int nx, int ny, int nz, Element::Type type, real_t sx, real_t sy, real_t sz, bool sfc_ordering) | mfem::Mesh | protected |
| Make3D24TetsFromHex(int nx, int ny, int nz, real_t sx, real_t sy, real_t sz) | mfem::Mesh | protected |
| MakeCartesian1D(int n, real_t sx=1.0) | mfem::Mesh | static |
| MakeCartesian2D(int nx, int ny, Element::Type type, bool generate_edges=false, real_t sx=1.0, real_t sy=1.0, bool sfc_ordering=true) | mfem::Mesh | static |
| MakeCartesian2DWith4TrisPerQuad(int nx, int ny, real_t sx=1.0, real_t sy=1.0) | mfem::Mesh | static |
| MakeCartesian2DWith5QuadsPerQuad(int nx, int ny, real_t sx=1.0, real_t sy=1.0) | mfem::Mesh | static |
| MakeCartesian3D(int nx, int ny, int nz, Element::Type type, real_t sx=1.0, real_t sy=1.0, real_t sz=1.0, bool sfc_ordering=true) | mfem::Mesh | static |
| MakeCartesian3DWith24TetsPerHex(int nx, int ny, int nz, real_t sx=1.0, real_t sy=1.0, real_t sz=1.0) | mfem::Mesh | static |
| MakePeriodic(const Mesh &orig_mesh, const std::vector< int > &v2v) | mfem::Mesh | static |
| MakeRefined(ParMesh &orig_mesh, int ref_factor, int ref_type) | mfem::ParMesh | static |
| mfem::Mesh::MakeRefined(Mesh &orig_mesh, int ref_factor, int ref_type) | mfem::Mesh | static |
| mfem::Mesh::MakeRefined(Mesh &orig_mesh, const Array< int > &ref_factors, int ref_type) | mfem::Mesh | static |
| MakeRefined_(ParMesh &orig_mesh, int ref_factor, int ref_type) | mfem::ParMesh | protected |
| mfem::Mesh::MakeRefined_(Mesh &orig_mesh, const Array< int > &ref_factors, int ref_type) | mfem::Mesh | protected |
| MakeSimplicial(ParMesh &orig_mesh) | mfem::ParMesh | static |
| mfem::Mesh::MakeSimplicial(const Mesh &orig_mesh) | mfem::Mesh | static |
| MakeSimplicial_(const Mesh &orig_mesh, int *vglobal) | mfem::Mesh | protected |
| MarkExternalBoundaries(Array< int > &bdr_marker, bool excl=true) const override | mfem::ParMesh | virtual |
| MarkForRefinement() | mfem::Mesh | protected |
| MarkNamedBoundaries(const std::string &set_name, Array< int > &bdr_marker) const | mfem::Mesh | virtual |
| MarkTetMeshForRefinement(const DSTable &v_to_v) override | mfem::ParMesh | protectedvirtual |
| MarkTriMeshForRefinement() | mfem::Mesh | protected |
| Mesh(const NCMesh &ncmesh) | mfem::Mesh | explicitprotected |
| Mesh() | mfem::Mesh | inline |
| Mesh(const Mesh &mesh, bool copy_nodes=true) | mfem::Mesh | explicit |
| Mesh(Mesh &&mesh) | mfem::Mesh | |
| Mesh(real_t *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::Mesh | inline |
| Mesh(const std::string &filename, int generate_edges=0, int refine=1, bool fix_orientation=true) | mfem::Mesh | explicit |
| Mesh(std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true) | mfem::Mesh | explicit |
| Mesh(Mesh *mesh_array[], int num_pieces) | mfem::Mesh | |
| Mesh(const NURBSExtension &ext) | mfem::Mesh | explicit |
| Mesh(int nx, int ny, int nz, Element::Type type, bool generate_edges=false, real_t sx=1.0, real_t sy=1.0, real_t sz=1.0, bool sfc_ordering=true) | mfem::Mesh | inline |
| Mesh(int nx, int ny, Element::Type type, bool generate_edges=false, real_t sx=1.0, real_t sy=1.0, bool sfc_ordering=true) | mfem::Mesh | inline |
| Mesh(int n, real_t sx=1.0) | mfem::Mesh | inlineexplicit |
| Mesh(Mesh *orig_mesh, int ref_factor, int ref_type) | mfem::Mesh | |
| mesh_geoms | mfem::Mesh | protected |
| meshgen | mfem::Mesh | protected |
| MeshGenerator() const | mfem::Mesh | inline |
| MoveNodes(const Vector &displacements) | mfem::Mesh | |
| MoveVertices(const Vector &displacements) | mfem::Mesh | |
| MyComm | mfem::ParMesh | protected |
| MyRank | mfem::ParMesh | protected |
| nbBoundaryFaces | mfem::Mesh | protected |
| nbInteriorFaces | mfem::Mesh | mutableprotected |
| nc_faces_info | mfem::Mesh | protected |
| ncmesh | mfem::Mesh | |
| NedelecFieldMFEMtoPUMI(apf::Mesh2 *apf_mesh, ParGridFunction *gf, apf::Field *nedelec_field) | mfem::ParPumiMesh | |
| NewElement(int geom) | mfem::Mesh | |
| NewNodes(GridFunction &nodes, bool make_owner=false) | mfem::Mesh | |
| Nodes | mfem::Mesh | protected |
| nodes_sequence | mfem::Mesh | protected |
| NodesUpdated() | mfem::Mesh | inline |
| Nonconforming() const | mfem::Mesh | inline |
| NonconformingDerefinement(Array< real_t > &elem_error, real_t threshold, int nc_limit=0, int op=1) override | mfem::ParMesh | protectedvirtual |
| NonconformingRefinement(const Array< Refinement > &refinements, int nc_limit=0) override | mfem::ParMesh | protectedvirtual |
| NONE enum value | mfem::Mesh | |
| NRanks | mfem::ParMesh | protected |
| NumOfBdrElements | mfem::Mesh | protected |
| NumOfEdges | mfem::Mesh | protected |
| NumOfElements | mfem::Mesh | protected |
| NumOfFaces | mfem::Mesh | protected |
| NumOfVertices | mfem::Mesh | protected |
| NURBSCoarsening(int cf=2, real_t tol=1.0e-12) | mfem::Mesh | |
| NURBSext | mfem::Mesh | |
| NURBSUniformRefinement(int rf=2, real_t tol=1.0e-12) override | mfem::ParMesh | protectedvirtual |
| NURBSUniformRefinement(const Array< int > &rf, real_t tol=1.e-12) override | mfem::ParMesh | protectedvirtual |
| Operation enum name | mfem::Mesh | |
| operator=(ParMesh &&mesh) | mfem::ParMesh | |
| operator=(const ParMesh &mesh)=delete | mfem::ParMesh | |
| mfem::Mesh::operator=(Mesh &&mesh) | mfem::Mesh | |
| mfem::Mesh::operator=(const Mesh &mesh)=delete | mfem::Mesh | |
| own_nodes | mfem::Mesh | protected |
| OwnsNodes() const | mfem::Mesh | inline |
| ParentXisMFEMtoPUMI(apf::Mesh2 *apf_mesh, int elemId, apf::MeshEntity *tet, const IntegrationRule &mfem_xi, apf::NewArray< apf::Vector3 > &pumi_xi, bool checkOrientation=true) | mfem::ParPumiMesh | |
| ParentXisPUMItoMFEM(apf::Mesh2 *apf_mesh, apf::MeshEntity *tet, int elemId, apf::NewArray< apf::Vector3 > &pumi_xi, bool checkOrientation=true) | mfem::ParPumiMesh | |
| ParMesh(const ParNCMesh &pncmesh) | mfem::ParMesh | protected |
| ParMesh() | mfem::ParMesh | inline |
| ParMesh(MPI_Comm comm, Mesh &mesh, const int *partitioning_=nullptr, int part_method=1) | mfem::ParMesh | |
| ParMesh(const ParMesh &pmesh, bool copy_nodes=true) | mfem::ParMesh | explicit |
| ParMesh(MPI_Comm comm, std::istream &input, bool refine=true, int generate_edges=1, bool fix_orientation=true) | mfem::ParMesh | |
| ParMesh(ParMesh *orig_mesh, int ref_factor, int ref_type) | mfem::ParMesh | |
| ParMesh(ParMesh &&mesh) | mfem::ParMesh | |
| ParPrint(std::ostream &out, const std::string &comments="") const | mfem::ParMesh | |
| ParPumiMesh(MPI_Comm comm, apf::Mesh2 *apf_mesh, int refine=1, bool fix_orientation=true) | mfem::ParPumiMesh | |
| pncmesh | mfem::ParMesh | |
| PrepareNodeReorder(DSTable **old_v_to_v, Table **old_elem_vert) | mfem::Mesh | protected |
| pri_t typedef | mfem::Mesh | |
| Print(std::ostream &out=mfem::out, const std::string &comments="") const override | mfem::ParMesh | virtual |
| Print(adios2stream &out) const override | mfem::ParMesh | virtual |
| print_shared | mfem::ParMesh | protected |
| PrintAsOne(std::ostream &out=mfem::out, const std::string &comments="") const | mfem::ParMesh | |
| PrintAsOneXG(std::ostream &out=mfem::out) | mfem::ParMesh | |
| PrintAsSerial(std::ostream &out=mfem::out, const std::string &comments="") const | mfem::ParMesh | |
| PrintBdrVTU(std::string fname, VTKFormat format=VTKFormat::ASCII, bool high_order_output=false, int compression_level=0) | mfem::Mesh | |
| PrintCharacteristics(Vector *Vh=NULL, Vector *Vk=NULL, std::ostream &os=mfem::out) | mfem::Mesh | |
| PrintElement(const Element *el, std::ostream &os) | mfem::Mesh | protectedstatic |
| PrintElementsByGeometry(int dim, const Array< int > &num_elems_by_geom, std::ostream &os) | mfem::Mesh | static |
| PrintElementsWithPartitioning(int *partitioning, std::ostream &os, int interior_faces=0) | mfem::Mesh | |
| PrintElementWithoutAttr(const Element *el, std::ostream &os) | mfem::Mesh | protectedstatic |
| Printer(std::ostream &os=mfem::out, std::string section_delimiter="", const std::string &comments="") const | mfem::Mesh | protected |
| PrintExodusII(const std::string fpath) | mfem::Mesh | |
| PrintInfo(std::ostream &out=mfem::out) override | mfem::ParMesh | virtual |
| PrintSharedEntities(const std::string &fname_prefix) const | mfem::ParMesh | |
| PrintSurfaces(const Table &Aface_face, std::ostream &os) const | mfem::Mesh | |
| PrintTopo(std::ostream &os, const Array< int > &e_to_k, const int version, const std::string &comment="") const | mfem::Mesh | protected |
| PrintVTK(std::ostream &os) | mfem::Mesh | |
| PrintVTK(std::ostream &os, int ref, int field_data=0) | mfem::Mesh | |
| PrintVTU(std::string pathname, VTKFormat format=VTKFormat::ASCII, bool high_order_output=false, int compression_level=0, bool bdr=false) override | mfem::ParMesh | virtual |
| mfem::Mesh::PrintVTU(std::ostream &os, int ref=1, VTKFormat format=VTKFormat::ASCII, bool high_order_output=false, int compression_level=0, bool bdr_elements=false) | mfem::Mesh | |
| PrintWithPartitioning(int *partitioning, std::ostream &os, int elem_attr=0) const | mfem::Mesh | |
| PrintXG(std::ostream &out=mfem::out) const override | mfem::ParMesh | virtual |
| pyr_t typedef | mfem::Mesh | |
| quad_t typedef | mfem::Mesh | |
| RandomRefinement(real_t prob, bool aniso=false, int nonconforming=-1, int nc_limit=0) | mfem::Mesh | |
| ReadCubit(const std::string &filename, int &curved, int &read_gf) | mfem::Mesh | protected |
| ReadElement(std::istream &input) | mfem::Mesh | protected |
| ReadElementWithoutAttr(std::istream &input) | mfem::Mesh | protected |
| ReadGmshMesh(std::istream &input, int &curved, int &read_gf) | mfem::Mesh | protected |
| ReadInlineMesh(std::istream &input, bool generate_edges=false) | mfem::Mesh | protected |
| ReadLineMesh(std::istream &input) | mfem::Mesh | protected |
| ReadMFEMMesh(std::istream &input, int version, 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, bool spacing=false) | mfem::Mesh | protected |
| ReadTrueGridMesh(std::istream &input) | mfem::Mesh | protected |
| ReadVTKMesh(std::istream &input, int &curved, int &read_gf, bool &finalize_topo) | mfem::Mesh | protected |
| ReadXML_VTKMesh(std::istream &input, int &curved, int &read_gf, bool &finalize_topo, const std::string &xml_prefix="") | mfem::Mesh | protected |
| REBALANCE enum value | mfem::Mesh | |
| Rebalance() | mfem::ParMesh | |
| Rebalance(const Array< int > &partition) | mfem::ParMesh | |
| RebalanceImpl(const Array< int > *partition) | mfem::ParMesh | protected |
| RedRefinement(int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle) | mfem::Mesh | inlineprotected |
| ReduceInt(int value) const override | mfem::ParMesh | virtual |
| ReduceMeshGen() | mfem::ParMesh | protected |
| REFINE enum value | mfem::Mesh | |
| RefineAtVertex(const Vertex &vert, real_t eps=0.0, int nonconforming=-1) | mfem::Mesh | |
| RefineByError(const Array< real_t > &elem_error, real_t threshold, int nonconforming=-1, int nc_limit=0) | mfem::Mesh | |
| RefineByError(const Vector &elem_error, real_t threshold, int nonconforming=-1, int nc_limit=0) | mfem::Mesh | |
| RefineGroups(const DSTable &v_to_v, int *middle) | mfem::ParMesh | protected |
| RefineGroups(int old_nv, const HashTable< Hashed2 > &v_to_v) | mfem::ParMesh | protected |
| RefineNURBSFromFile(std::string ref_file) | mfem::Mesh | |
| remove_unused_vertices | mfem::Mesh | static |
| RemoveInternalBoundaries() | mfem::Mesh | |
| RemoveUnusedVertices() | mfem::Mesh | |
| ReorderElements(const Array< int > &ordering, bool reorder_vertices=true) | mfem::Mesh | |
| ReorientTetMesh() override | mfem::ParMesh | virtual |
| ResetLazyData() | mfem::Mesh | protected |
| RotationPUMItoMFEM(apf::Mesh2 *apf_mesh, apf::MeshEntity *tet, int elemId) | mfem::ParPumiMesh | |
| Save(const std::string &fname, int precision=16) const override | mfem::ParMesh | virtual |
| SaveAsOne(const std::string &fname, int precision=16) const | mfem::ParMesh | |
| ScaleElements(real_t sf) | mfem::Mesh | |
| ScaleSubdomains(real_t sf) | mfem::Mesh | |
| sedge_ledge | mfem::ParMesh | protected |
| seg_t typedef | mfem::Mesh | |
| send_face_nbr_elements | mfem::ParMesh | |
| send_face_nbr_vertices | mfem::ParMesh | |
| sequence | mfem::Mesh | protected |
| SetAttribute(int i, int attr) | mfem::Mesh | |
| SetAttributes() override | mfem::ParMesh | virtual |
| SetBdrAttribute(int i, int attr) | mfem::Mesh | inline |
| SetCurvature(int order, bool discont=false, int space_dim=-1, int ordering=1) override | mfem::ParMesh | virtual |
| SetEmpty() | mfem::Mesh | protected |
| SetMeshGen() | mfem::Mesh | protected |
| SetNodalFESpace(FiniteElementSpace *nfes) override | mfem::ParMesh | virtual |
| SetNodalFESpace(ParFiniteElementSpace *npfes) | mfem::ParMesh | |
| SetNodalGridFunction(GridFunction *nodes, bool make_owner=false) | mfem::Mesh | |
| SetNode(int i, const real_t *coord) | mfem::Mesh | |
| SetNodes(const Vector &node_coord) | mfem::Mesh | |
| SetNodesOwner(bool nodes_owner) | mfem::Mesh | inline |
| SetPatchAttribute(int i, int attr) | mfem::Mesh | |
| SetPatchBdrAttribute(int i, int attr) | mfem::Mesh | |
| SetPrintShared(bool print) | mfem::ParMesh | inline |
| SetScaledNCMesh() | mfem::Mesh | inline |
| SetVertices(const Vector &vert_coord) | mfem::Mesh | |
| SetVerticesFromNodes(const GridFunction *nodes) | mfem::Mesh | protected |
| sface_lface | mfem::ParMesh | protected |
| shared_edges | mfem::ParMesh | protected |
| shared_quads | mfem::ParMesh | protected |
| shared_trias | mfem::ParMesh | protected |
| spaceDim | mfem::Mesh | protected |
| SpaceDimension() const | mfem::Mesh | inline |
| svert_lvert | mfem::ParMesh | protected |
| Swap(ParMesh &other) | mfem::ParMesh | |
| Swap(Mesh &other, bool non_geometry) | mfem::ParMesh | protected |
| SwapNodes(GridFunction *&nodes, int &own_nodes_) | mfem::Mesh | |
| tet_t typedef | mfem::Mesh | |
| TetMemory | mfem::Mesh | protected |
| tmp_vertex_parents | mfem::Mesh | protected |
| Transform(void(*f)(const Vector &, Vector &)) | mfem::Mesh | |
| Transform(VectorCoefficient &deformation) | mfem::Mesh | |
| Transformation | mfem::Mesh | protected |
| Transformation2 | mfem::Mesh | protected |
| TransformBdrElementToFace(Geometry::Type geom, int o, const IntegrationPoint &ip) | mfem::Mesh | static |
| tri_t typedef | mfem::Mesh | |
| UniformRefineGroups2D(int old_nv) | mfem::ParMesh | protected |
| UniformRefineGroups3D(int old_nv, int old_nedges, const DSTable &old_v_to_v, const STable3D &old_faces, Array< int > *f2qf) | mfem::ParMesh | protected |
| UniformRefinement(int i, const DSTable &, int *, int *, int *) | mfem::Mesh | protected |
| UniformRefinement(int ref_algo=0) | mfem::Mesh | |
| UniformRefinement2D() override | mfem::ParMesh | protectedvirtual |
| UniformRefinement2D_base(bool update_nodes=true) | mfem::Mesh | protected |
| UniformRefinement3D() override | mfem::ParMesh | protectedvirtual |
| UniformRefinement3D_base(Array< int > *f2qf=NULL, DSTable *v_to_v_p=NULL, bool update_nodes=true) | mfem::Mesh | protected |
| UnmarkInternalBoundaries(Array< int > &bdr_marker, bool excl=true) const override | mfem::ParMesh | virtual |
| UnmarkNamedBoundaries(const std::string &set_name, Array< int > &bdr_marker) const | mfem::Mesh | virtual |
| UpdateMesh(const ParMesh *AdaptedpMesh) | mfem::ParPumiMesh | |
| UpdateNodes() | mfem::Mesh | protected |
| UpdateNURBS() | mfem::Mesh | protected |
| VectorFieldMFEMtoPUMI(apf::Mesh2 *apf_mesh, ParGridFunction *grid_vel, apf::Field *vel_field, apf::Field *vel_mag_field) | mfem::ParPumiMesh | |
| vertices | mfem::Mesh | protected |
| vtk_quadratic_hex | mfem::Mesh | protectedstatic |
| vtk_quadratic_pyramid | mfem::Mesh | protectedstatic |
| vtk_quadratic_tet | mfem::Mesh | protectedstatic |
| vtk_quadratic_wedge | mfem::Mesh | protectedstatic |
| WantSkipSharedMaster(const NCMesh::Master &master) const | mfem::ParMesh | protected |
| ~Mesh() | mfem::Mesh | inlinevirtual |
| ~ParMesh() | mfem::ParMesh | virtual |
| ~ParPumiMesh() | mfem::ParPumiMesh | inlinevirtual |