|
| VectorTensorFiniteElement (const int dims, const int d, const int p, const int cbtype, const int obtype, const int M, const DofMapType dmtype) |
|
const DofToQuad & | GetDofToQuad (const IntegrationRule &ir, DofToQuad::Mode mode) const |
|
const DofToQuad & | GetDofToQuadOpen (const IntegrationRule &ir, DofToQuad::Mode mode) const |
|
const DofToQuad & | GetTensorDofToQuad (const IntegrationRule &ir, DofToQuad::Mode mode, const bool closed) const |
|
| VectorFiniteElement (int D, Geometry::Type G, int Do, int O, int M, int F=FunctionSpace::Pk) |
|
| FiniteElement (D, G, Do, O, F) |
|
| Jinv (D) |
|
| FiniteElement (int D, Geometry::Type G, int Do, int O, int F=FunctionSpace::Pk) |
|
int | GetDim () const |
| Returns the reference space dimension for the finite element. More...
|
|
Geometry::Type | GetGeomType () const |
| Returns the Geometry::Type of the reference element. More...
|
|
int | GetDof () const |
| Returns the number of degrees of freedom in the finite element. More...
|
|
int | GetOrder () const |
| Returns the order of the finite element. In the case of anisotropic orders, returns the maximum order. More...
|
|
bool | HasAnisotropicOrders () const |
| Returns true if the FiniteElement basis may be using different orders/degrees in different spatial directions. More...
|
|
const int * | GetAnisotropicOrders () const |
| Returns an array containing the anisotropic orders/degrees. More...
|
|
int | Space () const |
| Returns the type of space on each element. More...
|
|
int | GetRangeType () const |
|
int | GetDerivRangeType () const |
|
int | GetMapType () const |
|
int | GetDerivType () const |
|
int | GetDerivMapType () const |
|
void | CalcPhysShape (ElementTransformation &Trans, Vector &shape) const |
| Evaluate the values of all shape functions of a scalar finite element in physical space at the point described by Trans. More...
|
|
void | CalcPhysDShape (ElementTransformation &Trans, DenseMatrix &dshape) const |
| Evaluate the gradients of all shape functions of a scalar finite element in physical space at the point described by Trans. More...
|
|
const IntegrationRule & | GetNodes () const |
|
virtual void | CalcVShape (const IntegrationPoint &ip, DenseMatrix &shape) const |
| Evaluate the values of all shape functions of a vector finite element in reference space at the given point ip. More...
|
|
virtual void | CalcVShape (ElementTransformation &Trans, DenseMatrix &shape) const |
| Evaluate the values of all shape functions of a vector finite element in physical space at the point described by Trans. More...
|
|
void | CalcPhysVShape (ElementTransformation &Trans, DenseMatrix &shape) const |
| Equivalent to the CalcVShape() method with the same arguments. More...
|
|
virtual void | CalcDivShape (const IntegrationPoint &ip, Vector &divshape) const |
| Evaluate the divergence of all shape functions of a vector finite element in reference space at the given point ip. More...
|
|
void | CalcPhysDivShape (ElementTransformation &Trans, Vector &divshape) const |
| Evaluate the divergence of all shape functions of a vector finite element in physical space at the point described by Trans. More...
|
|
virtual void | CalcCurlShape (const IntegrationPoint &ip, DenseMatrix &curl_shape) const |
| Evaluate the curl of all shape functions of a vector finite element in reference space at the given point ip. More...
|
|
void | CalcPhysCurlShape (ElementTransformation &Trans, DenseMatrix &curl_shape) const |
| Evaluate the curl of all shape functions of a vector finite element in physical space at the point described by Trans. More...
|
|
virtual void | GetFaceDofs (int face, int **dofs, int *ndofs) const |
|
virtual void | CalcHessian (const IntegrationPoint &ip, DenseMatrix &Hessian) const |
| Evaluate the Hessians of all shape functions of a scalar finite element in reference space at the given point ip. More...
|
|
virtual void | CalcPhysHessian (ElementTransformation &Trans, DenseMatrix &Hessian) const |
| Evaluate the Hessian of all shape functions of a scalar finite element in reference space at the given point ip. More...
|
|
virtual void | CalcPhysLaplacian (ElementTransformation &Trans, Vector &Laplacian) const |
| Evaluate the Laplacian of all shape functions of a scalar finite element in reference space at the given point ip. More...
|
|
virtual void | CalcPhysLinLaplacian (ElementTransformation &Trans, Vector &Laplacian) const |
|
virtual void | GetLocalInterpolation (ElementTransformation &Trans, DenseMatrix &I) const |
| Return the local interpolation matrix I (Dof x Dof) where the fine element is the image of the base geometry under the given transformation. More...
|
|
virtual void | GetLocalRestriction (ElementTransformation &Trans, DenseMatrix &R) const |
| Return a local restriction matrix R (Dof x Dof) mapping fine dofs to coarse dofs. More...
|
|
virtual void | GetTransferMatrix (const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &I) const |
| Return interpolation matrix, I, which maps dofs from a coarse element, fe, to the fine dofs on this finite element. More...
|
|
virtual void | Project (Coefficient &coeff, ElementTransformation &Trans, Vector &dofs) const |
|
virtual void | Project (VectorCoefficient &vc, ElementTransformation &Trans, Vector &dofs) const |
|
virtual void | ProjectMatrixCoefficient (MatrixCoefficient &mc, ElementTransformation &T, Vector &dofs) const |
|
virtual void | ProjectDelta (int vertex, Vector &dofs) const |
|
virtual void | Project (const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &I) const |
|
virtual void | ProjectGrad (const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &grad) const |
|
virtual void | ProjectCurl (const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &curl) const |
|
virtual void | ProjectDiv (const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &div) const |
|
virtual | ~FiniteElement () |
|
| TensorBasisElement (const int dims, const int p, const int btype, const DofMapType dmtype) |
|
int | GetBasisType () const |
|
const Poly_1D::Basis & | GetBasis1D () const |
|
const Array< int > & | GetDofMap () const |
| Get an Array<int> that maps lexicographically ordered indices to the indices of the respective nodes/dofs/basis functions. If the dofs are ordered lexicographically, i.e. the mapping is identity, the returned Array will be empty. More...
|
|
|
enum | { SCALAR,
VECTOR
} |
| Enumeration for RangeType and DerivRangeType. More...
|
|
enum | { VALUE,
INTEGRAL,
H_DIV,
H_CURL
} |
| Enumeration for MapType: defines how reference functions are mapped to physical space. More...
|
|
enum | { NONE,
GRAD,
DIV,
CURL
} |
| Enumeration for DerivType: defines which derivative method is implemented. More...
|
|
enum | DofMapType { L2_DOF_MAP = 0,
H1_DOF_MAP = 1,
Sr_DOF_MAP = 2
} |
|
static bool | IsClosedType (int b_type) |
|
static bool | IsOpenType (int b_type) |
|
static int | VerifyClosed (int b_type) |
|
static int | VerifyOpen (int b_type) |
|
static int | VerifyNodal (int b_type) |
|
static Geometry::Type | GetTensorProductGeometry (int dim) |
|
static int | Pow (int base, int dim) |
| Return base raised to the power dim. More...
|
|
void | SetDerivMembers () |
|
void | CalcVShape_RT (ElementTransformation &Trans, DenseMatrix &shape) const |
|
void | CalcVShape_ND (ElementTransformation &Trans, DenseMatrix &shape) const |
|
void | Project_RT (const double *nk, const Array< int > &d2n, VectorCoefficient &vc, ElementTransformation &Trans, Vector &dofs) const |
|
void | ProjectMatrixCoefficient_RT (const double *nk, const Array< int > &d2n, MatrixCoefficient &mc, ElementTransformation &T, Vector &dofs) const |
|
void | Project_RT (const double *nk, const Array< int > &d2n, const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &I) const |
|
void | ProjectGrad_RT (const double *nk, const Array< int > &d2n, const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &grad) const |
|
void | ProjectCurl_ND (const double *tk, const Array< int > &d2t, const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &curl) const |
|
void | ProjectCurl_RT (const double *nk, const Array< int > &d2n, const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &curl) const |
|
void | Project_ND (const double *tk, const Array< int > &d2t, VectorCoefficient &vc, ElementTransformation &Trans, Vector &dofs) const |
|
void | ProjectMatrixCoefficient_ND (const double *tk, const Array< int > &d2t, MatrixCoefficient &mc, ElementTransformation &T, Vector &dofs) const |
|
void | Project_ND (const double *tk, const Array< int > &d2t, const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &I) const |
|
void | ProjectGrad_ND (const double *tk, const Array< int > &d2t, const FiniteElement &fe, ElementTransformation &Trans, DenseMatrix &grad) const |
|
void | LocalInterpolation_RT (const VectorFiniteElement &cfe, const double *nk, const Array< int > &d2n, ElementTransformation &Trans, DenseMatrix &I) const |
|
void | LocalInterpolation_ND (const VectorFiniteElement &cfe, const double *tk, const Array< int > &d2t, ElementTransformation &Trans, DenseMatrix &I) const |
|
void | LocalRestriction_RT (const double *nk, const Array< int > &d2n, ElementTransformation &Trans, DenseMatrix &R) const |
|
void | LocalRestriction_ND (const double *tk, const Array< int > &d2t, ElementTransformation &Trans, DenseMatrix &R) const |
|
static const VectorFiniteElement & | CheckVectorFE (const FiniteElement &fe) |
|
Definition at line 1910 of file fe.hpp.