|
| | ParMesh (const ParMesh &pmesh, bool copy_nodes=true) |
| |
| | ParMesh (MPI_Comm comm, Mesh &mesh, int *partitioning_=NULL, int part_method=1) |
| |
| MPI_Comm | GetComm () const |
| |
| int | GetNRanks () const |
| |
| int | GetMyRank () const |
| |
| int | GetNGroups () |
| |
| int | GroupNVertices (int group) |
| |
| int | GroupNEdges (int group) |
| |
| int | GroupNFaces (int group) |
| |
| int | GroupVertex (int group, int i) |
| |
| void | GroupEdge (int group, int i, int &edge, int &o) |
| |
| void | GroupFace (int group, int i, int &face, int &o) |
| |
| void | GenerateOffsets (int N, HYPRE_Int loc_sizes[], Array< HYPRE_Int > *offsets[]) const |
| |
| void | ExchangeFaceNbrData () |
| |
| void | ExchangeFaceNbrNodes () |
| |
| int | GetNFaceNeighbors () const |
| |
| int | GetFaceNbrGroup (int fn) const |
| |
| int | GetFaceNbrRank (int fn) const |
| |
| Table * | GetFaceToAllElementTable () const |
| |
| FaceElementTransformations * | GetSharedFaceTransformations (int sf, bool fill2=true) |
| |
| int | GetNSharedFaces () const |
| | Return the number of shared faces (3D), edges (2D), vertices (1D) More...
|
| |
| int | GetSharedFace (int sface) const |
| | Return the local face index for the given shared face. More...
|
| |
| virtual void | ReorientTetMesh () |
| | See the remarks for the serial version in mesh.hpp. More...
|
| |
| virtual long | ReduceInt (int value) const |
| | Utility function: sum integers from all processors (Allreduce). More...
|
| |
| void | RefineGroups (const DSTable &v_to_v, int *middle) |
| | Update the groups after tet refinement. More...
|
| |
| void | Rebalance () |
| | Load balance the mesh. NC meshes only. More...
|
| |
| virtual void | Print (std::ostream &out=std::cout) const |
| |
| virtual void | PrintXG (std::ostream &out=std::cout) const |
| |
| void | PrintAsOne (std::ostream &out=std::cout) |
| |
| void | PrintAsOneXG (std::ostream &out=std::cout) |
| | Old mesh format (Netgen/Truegrid) version of 'PrintAsOne'. More...
|
| |
| virtual void | PrintInfo (std::ostream &out=std::cout) |
| | Print various parallel mesh stats. More...
|
| |
| virtual | ~ParMesh () |
| |
| | Mesh () |
| |
| | Mesh (const Mesh &mesh, bool copy_nodes=true) |
| |
| | Mesh (int _Dim, int NVert, int NElem, int NBdrElem=0, int _spaceDim=-1) |
| |
| Element * | NewElement (int geom) |
| |
| void | AddVertex (const double *) |
| |
| void | AddTri (const int *vi, int attr=1) |
| |
| void | AddTriangle (const int *vi, int attr=1) |
| |
| void | AddQuad (const int *vi, int attr=1) |
| |
| void | AddTet (const int *vi, int attr=1) |
| |
| void | AddHex (const int *vi, int attr=1) |
| |
| void | AddHexAsTets (const int *vi, int attr=1) |
| |
| void | AddElement (Element *elem) |
| |
| void | AddBdrElement (Element *elem) |
| |
| void | AddBdrSegment (const int *vi, int attr=1) |
| |
| void | AddBdrTriangle (const int *vi, int attr=1) |
| |
| void | AddBdrQuad (const int *vi, int attr=1) |
| |
| void | AddBdrQuadAsTriangles (const int *vi, int attr=1) |
| |
| void | GenerateBoundaryElements () |
| |
| void | FinalizeTriMesh (int generate_edges=0, int refine=0, bool fix_orientation=true) |
| |
| void | FinalizeQuadMesh (int generate_edges=0, int refine=0, bool fix_orientation=true) |
| |
| void | FinalizeTetMesh (int generate_edges=0, int refine=0, bool fix_orientation=true) |
| |
| void | FinalizeHexMesh (int generate_edges=0, int refine=0, bool fix_orientation=true) |
| |
| void | SetAttributes () |
| |
| void | GetGeckoElementReordering (Array< int > &ordering) |
| |
| void | ReorderElements (const Array< int > &ordering, bool reorder_vertices=true) |
| |
| | 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) |
| |
| | Mesh (int nx, int ny, Element::Type type, int generate_edges=0, double sx=1.0, double sy=1.0) |
| |
| | Mesh (int n, double sx=1.0) |
| |
| | Mesh (const char *filename, int generate_edges=0, int refine=1, bool fix_orientation=true) |
| |
| | Mesh (std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true) |
| |
| | Mesh (Mesh *mesh_array[], int num_pieces) |
| | Create a disjoint mesh from the given mesh array. More...
|
| |
| void | Load (std::istream &input, int generate_edges=0, int refine=1, bool fix_orientation=true) |
| |
| int | MeshGenerator () |
| |
| int | GetNV () const |
| |
| int | GetNE () const |
| | Returns number of elements. More...
|
| |
| int | GetNBE () const |
| | Returns number of boundary elements. More...
|
| |
| int | GetNEdges () const |
| | Return the number of edges. More...
|
| |
| int | GetNFaces () const |
| | Return the number of faces in a 3D mesh. More...
|
| |
| int | GetNumFaces () const |
| | Return the number of faces (3D), edges (2D) or vertices (1D). More...
|
| |
| long | GetGlobalNE () const |
| | Return the total (global) number of elements. More...
|
| |
| int | EulerNumber () const |
| | Equals 1 + num_holes - num_loops. More...
|
| |
| int | EulerNumber2D () const |
| | Equals 1 - num_holes. More...
|
| |
| int | Dimension () const |
| |
| int | SpaceDimension () const |
| |
| const double * | GetVertex (int i) const |
| | Return pointer to vertex i's coordinates. More...
|
| |
| double * | GetVertex (int i) |
| | Return pointer to vertex i's coordinates. More...
|
| |
| const Element *const * | GetElementsArray () const |
| |
| const Element * | GetElement (int i) const |
| |
| Element * | GetElement (int i) |
| |
| const Element * | GetBdrElement (int i) const |
| |
| Element * | GetBdrElement (int i) |
| |
| const Element * | GetFace (int i) const |
| |
| int | GetFaceBaseGeometry (int i) const |
| |
| int | GetElementBaseGeometry (int i=0) const |
| |
| int | GetBdrElementBaseGeometry (int i=0) const |
| |
| void | GetElementVertices (int i, Array< int > &dofs) const |
| | Returns the indices of the dofs of element i. More...
|
| |
| void | GetBdrElementVertices (int i, Array< int > &dofs) const |
| | Returns the indices of the dofs of boundary element i. More...
|
| |
| void | GetElementEdges (int i, Array< int > &edges, Array< int > &cor) const |
| | Return the indices and the orientations of all edges of element i. More...
|
| |
| void | GetBdrElementEdges (int i, Array< int > &edges, Array< int > &cor) const |
| | Return the indices and the orientations of all edges of bdr element i. More...
|
| |
| void | GetFaceEdges (int i, Array< int > &, Array< int > &) const |
| |
| void | GetFaceVertices (int i, Array< int > &vert) const |
| | Returns the indices of the vertices of face i. More...
|
| |
| void | GetEdgeVertices (int i, Array< int > &vert) const |
| | Returns the indices of the vertices of edge i. More...
|
| |
| Table * | GetFaceEdgeTable () const |
| | Returns the face-to-edge Table (3D) More...
|
| |
| Table * | GetEdgeVertexTable () const |
| | Returns the edge-to-vertex Table (3D) More...
|
| |
| void | GetElementFaces (int i, Array< int > &, Array< int > &) const |
| | Return the indices and the orientations of all faces of element i. More...
|
| |
| void | GetBdrElementFace (int i, int *, int *) const |
| | Return the index and the orientation of the face of bdr element i. (3D) More...
|
| |
| int | GetBdrElementEdgeIndex (int i) const |
| |
| void | GetBdrElementAdjacentElement (int bdr_el, int &el, int &info) const |
| | For the given boundary element, bdr_el, return its adjacent element and its info, i.e. 64*local_bdr_index+bdr_orientation. More...
|
| |
| int | GetElementType (int i) const |
| | Returns the type of element i. More...
|
| |
| int | GetBdrElementType (int i) const |
| | Returns the type of boundary element i. More...
|
| |
| void | GetPointMatrix (int i, DenseMatrix &pointmat) const |
| |
| void | GetBdrPointMatrix (int i, DenseMatrix &pointmat) const |
| |
| void | GetElementTransformation (int i, IsoparametricTransformation *ElTr) |
| |
| ElementTransformation * | GetElementTransformation (int i) |
| | Returns the transformation defining the i-th element. More...
|
| |
| void | GetElementTransformation (int i, const Vector &nodes, IsoparametricTransformation *ElTr) |
| |
| ElementTransformation * | GetBdrElementTransformation (int i) |
| | Returns the transformation defining the i-th boundary element. More...
|
| |
| void | GetBdrElementTransformation (int i, IsoparametricTransformation *ElTr) |
| |
| void | GetFaceTransformation (int i, IsoparametricTransformation *FTr) |
| |
| ElementTransformation * | GetFaceTransformation (int FaceNo) |
| | Returns the transformation defining the given face element. More...
|
| |
| void | GetEdgeTransformation (int i, IsoparametricTransformation *EdTr) |
| |
| ElementTransformation * | GetEdgeTransformation (int EdgeNo) |
| | Returns the transformation defining the given face element. More...
|
| |
| FaceElementTransformations * | GetFaceElementTransformations (int FaceNo, int mask=31) |
| |
| FaceElementTransformations * | GetInteriorFaceTransformations (int FaceNo) |
| |
| FaceElementTransformations * | GetBdrFaceTransformations (int BdrElemNo) |
| |
| bool | FaceIsInterior (int FaceNo) const |
| | Return true if the given face is interior. More...
|
| |
| void | GetFaceElements (int Face, int *Elem1, int *Elem2) |
| |
| void | GetFaceInfos (int Face, int *Inf1, int *Inf2) |
| |
| int | GetFaceGeometryType (int Face) const |
| |
| int | GetFaceElementType (int Face) const |
| |
| void | CheckElementOrientation (bool fix_it=true) |
| | Check the orientation of the elements. More...
|
| |
| void | CheckBdrElementOrientation (bool fix_it=true) |
| | Check the orientation of the boundary elements. More...
|
| |
| int | GetAttribute (int i) const |
| | Return the attribute of element i. More...
|
| |
| int | GetBdrAttribute (int i) const |
| | Return the attribute of boundary element i. More...
|
| |
| const Table & | ElementToElementTable () |
| |
| const Table & | ElementToFaceTable () const |
| |
| const Table & | ElementToEdgeTable () const |
| |
| Table * | GetVertexToElementTable () |
| | The returned Table must be destroyed by the caller. More...
|
| |
| Table * | GetFaceToElementTable () const |
| |
| int * | CartesianPartitioning (int nxyz[]) |
| |
| int * | GeneratePartitioning (int nparts, int part_method=1) |
| |
| void | CheckPartitioning (int *partitioning) |
| |
| void | CheckDisplacements (const Vector &displacements, double &tmax) |
| |
| void | MoveVertices (const Vector &displacements) |
| |
| void | GetVertices (Vector &vert_coord) const |
| |
| void | SetVertices (const Vector &vert_coord) |
| |
| void | GetNode (int i, double *coord) |
| |
| void | SetNode (int i, const double *coord) |
| |
| void | MoveNodes (const Vector &displacements) |
| |
| void | GetNodes (Vector &node_coord) const |
| |
| void | SetNodes (const Vector &node_coord) |
| |
| GridFunction * | GetNodes () |
| | Return a pointer to the internal node GridFunction (may be NULL). More...
|
| |
| const GridFunction * | GetNodes () const |
| |
| void | NewNodes (GridFunction &nodes, bool make_owner=false) |
| | Replace the internal node GridFunction with the given GridFunction. More...
|
| |
| void | SwapNodes (GridFunction *&nodes, int &own_nodes_) |
| |
| void | GetNodes (GridFunction &nodes) const |
| | Return the mesh nodes/vertices projected on the given GridFunction. More...
|
| |
| void | SetNodalFESpace (FiniteElementSpace *nfes) |
| |
| void | SetNodalGridFunction (GridFunction *nodes, bool make_owner=false) |
| |
| const FiniteElementSpace * | GetNodalFESpace () const |
| |
| void | SetCurvature (int order, bool discont=false, int space_dim=-1, int ordering=1) |
| |
| void | UniformRefinement () |
| |
| void | GeneralRefinement (const Array< Refinement > &refinements, int nonconforming=-1, int nc_limit=0) |
| |
| void | GeneralRefinement (const Array< int > &el_to_refine, int nonconforming=-1, int nc_limit=0) |
| |
| void | RandomRefinement (double prob, bool aniso=false, int nonconforming=-1, int nc_limit=0) |
| | Refine each element with given probability. Uses GeneralRefinement. More...
|
| |
| void | RefineAtVertex (const Vertex &vert, double eps=0.0, int nonconforming=-1) |
| | Refine elements sharing the specified vertex. Uses GeneralRefinement. More...
|
| |
| bool | RefineByError (const Array< double > &elem_error, double threshold, int nonconforming=-1, int nc_limit=0) |
| |
| bool | RefineByError (const Vector &elem_error, double threshold, int nonconforming=-1, int nc_limit=0) |
| |
| bool | DerefineByError (Array< double > &elem_error, double threshold, int nc_limit=0, int op=1) |
| |
| bool | DerefineByError (const Vector &elem_error, double threshold, int nc_limit=0, int op=1) |
| | Same as DerefineByError for an error vector. More...
|
| |
| void | KnotInsert (Array< KnotVector * > &kv) |
| |
| void | DegreeElevate (int t) |
| |
| void | EnsureNCMesh (bool triangles_nonconforming=false) |
| |
| bool | Conforming () const |
| |
| bool | Nonconforming () const |
| |
| const CoarseFineTransformations & | GetRefinementTransforms () |
| |
| Operation | GetLastOperation () const |
| | Return type of last modification of the mesh. More...
|
| |
| long | GetSequence () const |
| |
| void | PrintVTK (std::ostream &out) |
| | Print the mesh in VTK format (linear and quadratic meshes only). More...
|
| |
| void | PrintVTK (std::ostream &out, int ref, int field_data=0) |
| |
| void | GetElementColoring (Array< int > &colors, int el0=0) |
| |
| void | PrintWithPartitioning (int *partitioning, std::ostream &out, int elem_attr=0) const |
| |
| void | PrintElementsWithPartitioning (int *partitioning, std::ostream &out, int interior_faces=0) |
| |
| void | PrintSurfaces (const Table &Aface_face, std::ostream &out) const |
| | Print set of disjoint surfaces: More...
|
| |
| void | ScaleSubdomains (double sf) |
| |
| void | ScaleElements (double sf) |
| |
| void | Transform (void(*f)(const Vector &, Vector &)) |
| |
| void | Transform (VectorCoefficient &deformation) |
| |
| void | RemoveUnusedVertices () |
| | Remove unused vertices and rebuild mesh connectivity. More...
|
| |
| void | RemoveInternalBoundaries () |
| |
| double | GetElementSize (int i, int type=0) |
| |
| double | GetElementSize (int i, const Vector &dir) |
| |
| double | GetElementVolume (int i) |
| |
| void | GetBoundingBox (Vector &min, Vector &max, int ref=2) |
| |
| void | PrintCharacteristics (Vector *Vh=NULL, Vector *Vk=NULL, std::ostream &out=std::cout) |
| |
| void | MesquiteSmooth (const int mesquite_option=0) |
| |
| virtual | ~Mesh () |
| | Destroys mesh. More...
|
| |
|
| | ParMesh () |
| |
| | ParMesh (const ParNCMesh &pncmesh) |
| | Create from a nonconforming mesh. More...
|
| |
| int | GetEdgeSplittings (Element *edge, const DSTable &v_to_v, int *middle) |
| | Return a number(0-1) identifying how the given edge has been split. More...
|
| |
| int | GetFaceSplittings (Element *face, const DSTable &v_to_v, int *middle) |
| | Return a number(0-4) identifying how the given face has been split. More...
|
| |
| void | GetFaceNbrElementTransformation (int i, IsoparametricTransformation *ElTr) |
| |
| ElementTransformation * | GetGhostFaceTransformation (FaceElementTransformations *FETr, int face_type, int face_geom) |
| |
| virtual void | QuadUniformRefinement () |
| | Refine quadrilateral mesh. More...
|
| |
| virtual void | HexUniformRefinement () |
| | Refine a hexahedral mesh. More...
|
| |
| virtual void | NURBSUniformRefinement () |
| | Refine NURBS mesh. More...
|
| |
| virtual void | LocalRefinement (const Array< int > &marked_el, int type=3) |
| | This function is not public anymore. Use GeneralRefinement instead. More...
|
| |
| virtual void | NonconformingRefinement (const Array< Refinement > &refinements, int nc_limit=0) |
| | This function is not public anymore. Use GeneralRefinement instead. More...
|
| |
| virtual bool | NonconformingDerefinement (Array< double > &elem_error, double threshold, int nc_limit=0, int op=1) |
| | NC version of GeneralDerefinement. More...
|
| |
| void | DeleteFaceNbrData () |
| |
| bool | WantSkipSharedMaster (const NCMesh::Master &master) const |
| |
| void | Init () |
| |
| void | InitTables () |
| |
| void | DeleteTables () |
| |
| Element * | ReadElementWithoutAttr (std::istream &) |
| |
| Element * | ReadElement (std::istream &) |
| |
| void | ReadMFEMMesh (std::istream &input, bool mfem_v11, int &curved) |
| |
| void | ReadLineMesh (std::istream &input) |
| |
| void | ReadNetgen2DMesh (std::istream &input, int &curved) |
| |
| void | ReadNetgen3DMesh (std::istream &input) |
| |
| void | ReadTrueGridMesh (std::istream &input) |
| |
| void | ReadVTKMesh (std::istream &input, int &curved, int &read_gf) |
| |
| void | ReadNURBSMesh (std::istream &input, int &curved, int &read_gf) |
| |
| void | ReadInlineMesh (std::istream &input, int generate_edges=0) |
| |
| void | ReadGmshMesh (std::istream &input) |
| |
| void | ReadCubit (named_ifstream &input, int &curved, int &read_gf) |
| |
| void | SetMeshGen () |
| |
| double | GetLength (int i, int j) const |
| | Return the length of the segment from node i to node j. More...
|
| |
| void | GetElementJacobian (int i, DenseMatrix &J) |
| |
| void | MarkForRefinement () |
| |
| void | MarkTriMeshForRefinement () |
| |
| void | GetEdgeOrdering (DSTable &v_to_v, Array< int > &order) |
| |
| void | MarkTetMeshForRefinement () |
| |
| void | PrepareNodeReorder (DSTable **old_v_to_v, Table **old_elem_vert) |
| |
| void | DoNodeReorder (DSTable *old_v_to_v, Table *old_elem_vert) |
| |
| STable3D * | GetFacesTable () |
| |
| STable3D * | GetElementToFaceTable (int ret_ftbl=0) |
| |
| void | RedRefinement (int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle) |
| |
| void | GreenRefinement (int i, const DSTable &v_to_v, int *edge1, int *edge2, int *middle) |
| |
| void | Bisection (int i, const DSTable &, int *, int *, int *) |
| |
| void | Bisection (int i, const DSTable &, int *) |
| |
| void | UniformRefinement (int i, const DSTable &, int *, int *, int *) |
| |
| void | AverageVertices (int *indexes, int n, int result) |
| |
| void | InitRefinementTransforms () |
| |
| int | FindCoarseElement (int i) |
| |
| void | UpdateNodes () |
| | Update the nodes of a curved mesh after refinement. More...
|
| |
| void | DerefineMesh (const Array< int > &derefinements) |
| | Derefine elements once a list of derefinements is known. More...
|
| |
| void | LoadPatchTopo (std::istream &input, Array< int > &edge_to_knot) |
| | Read NURBS patch/macro-element mesh. More...
|
| |
| void | UpdateNURBS () |
| |
| void | PrintTopo (std::ostream &out, const Array< int > &e_to_k) const |
| |
| void | GetLocalPtToSegTransformation (IsoparametricTransformation &, int) |
| | Used in GetFaceElementTransformations (...) More...
|
| |
| void | GetLocalSegToTriTransformation (IsoparametricTransformation &loc, int i) |
| |
| void | GetLocalSegToQuadTransformation (IsoparametricTransformation &loc, int i) |
| |
| void | GetLocalTriToTetTransformation (IsoparametricTransformation &loc, int i) |
| | Used in GetFaceElementTransformations (...) More...
|
| |
| void | GetLocalQuadToHexTransformation (IsoparametricTransformation &loc, int i) |
| | Used in GetFaceElementTransformations (...) More...
|
| |
| void | GetLocalFaceTransformation (int face_type, int elem_type, IsoparametricTransformation &Transf, int inf) |
| | Used in GetFaceElementTransformations (...) More...
|
| |
| void | ApplyLocalSlaveTransformation (IsoparametricTransformation &transf, const FaceInfo &fi) |
| |
| bool | IsSlaveFace (const FaceInfo &fi) const |
| |
| void | GetVertexToVertexTable (DSTable &) const |
| |
| int | GetElementToEdgeTable (Table &, Array< int > &) |
| |
| void | AddPointFaceElement (int lf, int gf, int el) |
| | Used in GenerateFaces() More...
|
| |
| void | AddSegmentFaceElement (int lf, int gf, int el, int v0, int v1) |
| |
| void | AddTriangleFaceElement (int lf, int gf, int el, int v0, int v1, int v2) |
| |
| void | AddQuadFaceElement (int lf, int gf, int el, int v0, int v1, int v2, int v3) |
| |
| bool | FaceIsTrueInterior (int FaceNo) const |
| |
| void | FreeElement (Element *E) |
| |
| void | GenerateFaces () |
| |
| void | GenerateNCFaceInfo () |
| |
| void | InitMesh (int _Dim, int _spaceDim, int NVert, int NElem, int NBdrElem) |
| | Begin construction of a mesh. More...
|
| |
| void | InitBaseGeom () |
| |
| void | Make3D (int nx, int ny, int nz, Element::Type type, int generate_edges, double sx, double sy, double sz) |
| |
| void | Make2D (int nx, int ny, Element::Type type, int generate_edges, double sx, double sy) |
| |
| void | Make1D (int n, double sx=1.0) |
| | Creates a 1D mesh for the interval [0,sx] divided into n equal intervals. More...
|
| |
| void | InitFromNCMesh (const NCMesh &ncmesh) |
| | Initialize vertices/elements/boundary/tables from a nonconforming mesh. More...
|
| |
| | Mesh (const NCMesh &ncmesh) |
| | Create from a nonconforming mesh. More...
|
| |
| void | Swap (Mesh &other, bool non_geometry=false) |
| |