|
MFEM
v3.3.2
Finite element discretization library
|
#include <fem_extras.hpp>
Public Member Functions | |
| H1_FESpace (Mesh *m, const int p, const int space_dim=3, const int type=BasisType::GaussLobatto, int vdim=1, int order=Ordering::byNODES) | |
| ~H1_FESpace () | |
Public Member Functions inherited from mfem::FiniteElementSpace | |
| FiniteElementSpace (Mesh *mesh, const FiniteElementCollection *fec, int vdim=1, int ordering=Ordering::byNODES) | |
| Mesh * | GetMesh () const |
| Returns the mesh. More... | |
| NURBSExtension * | GetNURBSext () |
| NURBSExtension * | StealNURBSext () |
| bool | Conforming () const |
| bool | Nonconforming () const |
| const SparseMatrix * | GetConformingProlongation () const |
| const SparseMatrix * | GetConformingRestriction () const |
| virtual const Operator * | GetProlongationMatrix () |
| virtual const SparseMatrix * | GetRestrictionMatrix () |
| int | GetVDim () const |
| Returns vector dimension. More... | |
| int | GetOrder (int i) const |
| Returns the order of the i'th finite element. More... | |
| int | GetFaceOrder (int i) const |
| Returns the order of the i'th face finite element. More... | |
| int | GetNDofs () const |
| Returns number of degrees of freedom. More... | |
| int | GetVSize () const |
| virtual int | GetTrueVSize () const |
| Return the number of vector true (conforming) dofs. More... | |
| int | GetNConformingDofs () const |
| int | GetConformingVSize () const |
| Ordering::Type | GetOrdering () const |
| Return the ordering method. More... | |
| const FiniteElementCollection * | FEColl () const |
| int | GetNVDofs () const |
| int | GetNEDofs () const |
| int | GetNFDofs () const |
| int | GetNE () const |
| Returns number of elements in the mesh. More... | |
| int | GetNV () const |
| Returns number of nodes in the mesh. More... | |
| int | GetNBE () const |
| Returns number of boundary elements in the mesh. More... | |
| int | GetElementType (int i) const |
| Returns the type of element i. More... | |
| void | GetElementVertices (int i, Array< int > &vertices) const |
| Returns the vertices of element i. More... | |
| int | GetBdrElementType (int i) const |
| Returns the type of boundary element i. More... | |
| ElementTransformation * | GetElementTransformation (int i) const |
| Returns ElementTransformation for the i'th element. More... | |
| void | GetElementTransformation (int i, IsoparametricTransformation *ElTr) |
| ElementTransformation * | GetBdrElementTransformation (int i) const |
| Returns ElementTransformation for the i'th boundary element. More... | |
| int | GetAttribute (int i) const |
| int | GetBdrAttribute (int i) const |
| virtual void | GetElementDofs (int i, Array< int > &dofs) const |
| Returns indexes of degrees of freedom in array dofs for i'th element. More... | |
| virtual void | GetBdrElementDofs (int i, Array< int > &dofs) const |
| Returns indexes of degrees of freedom for i'th boundary element. More... | |
| virtual void | GetFaceDofs (int i, Array< int > &dofs) const |
| void | GetEdgeDofs (int i, Array< int > &dofs) const |
| void | GetVertexDofs (int i, Array< int > &dofs) const |
| void | GetElementInteriorDofs (int i, Array< int > &dofs) const |
| void | GetFaceInteriorDofs (int i, Array< int > &dofs) const |
| int | GetNumElementInteriorDofs (int i) const |
| void | GetEdgeInteriorDofs (int i, Array< int > &dofs) const |
| void | DofsToVDofs (Array< int > &dofs, int ndofs=-1) const |
| void | DofsToVDofs (int vd, Array< int > &dofs, int ndofs=-1) const |
| int | DofToVDof (int dof, int vd, int ndofs=-1) const |
| int | VDofToDof (int vdof) const |
| void | GetElementVDofs (int i, Array< int > &vdofs) const |
| Returns indexes of degrees of freedom in array dofs for i'th element. More... | |
| void | GetBdrElementVDofs (int i, Array< int > &vdofs) const |
| Returns indexes of degrees of freedom for i'th boundary element. More... | |
| void | GetFaceVDofs (int i, Array< int > &vdofs) const |
| Returns indexes of degrees of freedom for i'th face element (2D and 3D). More... | |
| void | GetEdgeVDofs (int i, Array< int > &vdofs) const |
| Returns indexes of degrees of freedom for i'th edge. More... | |
| void | GetVertexVDofs (int i, Array< int > &vdofs) const |
| void | GetElementInteriorVDofs (int i, Array< int > &vdofs) const |
| void | GetEdgeInteriorVDofs (int i, Array< int > &vdofs) const |
| void | RebuildElementToDofTable () |
| void | ReorderElementToDofTable () |
| Reorder the scalar DOFs based on the element ordering. More... | |
| void | BuildDofToArrays () |
| const Table & | GetElementToDofTable () const |
| const Table & | GetBdrElementToDofTable () const |
| int | GetElementForDof (int i) const |
| int | GetLocalDofForDof (int i) const |
| const FiniteElement * | GetFE (int i) const |
| Returns pointer to the FiniteElement associated with i'th element. More... | |
| const FiniteElement * | GetBE (int i) const |
| Returns pointer to the FiniteElement for the i'th boundary element. More... | |
| const FiniteElement * | GetFaceElement (int i) const |
| const FiniteElement * | GetEdgeElement (int i) const |
| const FiniteElement * | GetTraceElement (int i, int geom_type) const |
| Return the trace element from element 'i' to the given 'geom_type'. More... | |
| virtual void | GetEssentialVDofs (const Array< int > &bdr_attr_is_ess, Array< int > &ess_vdofs, int component=-1) const |
| virtual void | GetEssentialTrueDofs (const Array< int > &bdr_attr_is_ess, Array< int > &ess_tdof_list, int component=-1) |
| void | ConvertToConformingVDofs (const Array< int > &dofs, Array< int > &cdofs) |
| void | ConvertFromConformingVDofs (const Array< int > &cdofs, Array< int > &dofs) |
| SparseMatrix * | D2C_GlobalRestrictionMatrix (FiniteElementSpace *cfes) |
| SparseMatrix * | D2Const_GlobalRestrictionMatrix (FiniteElementSpace *cfes) |
| SparseMatrix * | H2L_GlobalRestrictionMatrix (FiniteElementSpace *lfes) |
| virtual void | Update (bool want_transform=true) |
| const Operator * | GetUpdateOperator () |
| Get the GridFunction update matrix. More... | |
| void | SetUpdateOperatorOwner (bool own) |
| Set the ownership of the update operator: if set to false, the Operator returned by GetUpdateOperator() must be deleted outside the FiniteElementSpace. More... | |
| virtual void | UpdatesFinished () |
| Free GridFunction transformation matrix (if any), to save memory. More... | |
| long | GetSequence () const |
| Return update counter (see Mesh::sequence) More... | |
| void | Save (std::ostream &out) const |
| virtual | ~FiniteElementSpace () |
Additional Inherited Members | |
Static Public Member Functions inherited from mfem::FiniteElementSpace | |
| static void | AdjustVDofs (Array< int > &vdofs) |
| static void | MarkerToList (const Array< int > &marker, Array< int > &list) |
| Convert a Boolean marker array to a list containing all marked indices. More... | |
| static void | ListToMarker (const Array< int > &list, int marker_size, Array< int > &marker, int mark_val=-1) |
Protected Member Functions inherited from mfem::FiniteElementSpace | |
| void | UpdateNURBS () |
| void | Construct () |
| void | Destroy () |
| void | BuildElementToDofTable () const |
| void | GetEdgeFaceDofs (int type, int index, Array< int > &dofs) const |
| void | GetConformingInterpolation () const |
| Calculate the cP and cR matrices for a nonconforming mesh. More... | |
| void | MakeVDimMatrix (SparseMatrix &mat) const |
| SparseMatrix * | RefinementMatrix (int old_ndofs, const Table *old_elem_dof) |
| Calculate GridFunction interpolation matrix after mesh refinement. More... | |
| void | GetLocalDerefinementMatrices (int geom, const CoarseFineTransformations &dt, DenseTensor &localR) |
| SparseMatrix * | DerefinementMatrix (int old_ndofs, const Table *old_elem_dof) |
| Calculate GridFunction restriction matrix after mesh derefinement. More... | |
Protected Attributes inherited from mfem::FiniteElementSpace | |
| Mesh * | mesh |
| The mesh that FE space lives on. More... | |
| const FiniteElementCollection * | fec |
| int | vdim |
| Vector dimension (number of unknowns per degree of freedom). More... | |
| Ordering::Type | ordering |
| int | ndofs |
| Number of degrees of freedom. Number of unknowns are ndofs*vdim. More... | |
| int | nvdofs |
| int | nedofs |
| int | nfdofs |
| int | nbdofs |
| int * | fdofs |
| int * | bdofs |
| Table * | elem_dof |
| Table * | bdrElem_dof |
| Array< int > | dof_elem_array |
| Array< int > | dof_ldof_array |
| NURBSExtension * | NURBSext |
| int | own_ext |
| SparseMatrix * | cP |
| SparseMatrix * | cR |
| Conforming restriction matrix such that cR.cP=I. More... | |
| bool | cP_is_set |
| Operator * | T |
| Transformation to apply to GridFunctions after space Update(). More... | |
| bool | own_T |
| long | sequence |
The H1_FESpace class is a FiniteElementSpace which automatically allocates and destroys its own FiniteElementCollection, in this case an H1_FECollection object.
Definition at line 28 of file fem_extras.hpp.
| mfem::miniapps::H1_FESpace::H1_FESpace | ( | Mesh * | m, |
| const int | p, | ||
| const int | space_dim = 3, |
||
| const int | type = BasisType::GaussLobatto, |
||
| int | vdim = 1, |
||
| int | order = Ordering::byNODES |
||
| ) |
Definition at line 22 of file fem_extras.cpp.
| mfem::miniapps::H1_FESpace::~H1_FESpace | ( | ) |
Definition at line 30 of file fem_extras.cpp.
1.8.5