Reference documentation for deal.II version 9.5.0
|
#include <deal.II/base/tensor_polynomials_base.h>
Public Member Functions | |
TensorPolynomialsBase (const unsigned int deg, const unsigned int n_polynomials) | |
TensorPolynomialsBase (TensorPolynomialsBase< dim > &&)=default | |
TensorPolynomialsBase (const TensorPolynomialsBase< dim > &)=default | |
virtual | ~TensorPolynomialsBase ()=default |
virtual void | evaluate (const Point< dim > &unit_point, std::vector< Tensor< 1, dim > > &values, std::vector< Tensor< 2, dim > > &grads, std::vector< Tensor< 3, dim > > &grad_grads, std::vector< Tensor< 4, dim > > &third_derivatives, std::vector< Tensor< 5, dim > > &fourth_derivatives) const =0 |
unsigned int | n () const |
unsigned int | degree () const |
virtual std::unique_ptr< TensorPolynomialsBase< dim > > | clone () const =0 |
virtual std::string | name () const =0 |
Private Attributes | |
const unsigned int | polynomial_degree |
const unsigned int | n_pols |
This class provides a framework for the finite element polynomial classes for use with finite element classes that are derived from FE_PolyTensor. An object of this type (or rather of a type derived from this class) is stored as a member variable in each object of type FE_PolyTensor.
Any derived class must provide the most basic properties for shape functions evaluated on the reference cell. This includes, but is not limited to, implementing the evaluate(), name(), and clone() member functions. These functions are necessary to store the most basic information of how the polynomials in the derived class evaluate at a given point on the reference cell. More information on each function can be found in the corresponding function's documentation.
Some classes that derive from this class include
PolynomialsABF
PolynomialsBDM
PolynomialsBernardiRaugel
PolynomialsNedelec
PolynomialsRaviartThomas
PolynomialsRT_Bubbles
Definition at line 62 of file tensor_polynomials_base.h.
TensorPolynomialsBase< dim >::TensorPolynomialsBase | ( | const unsigned int | deg, |
const unsigned int | n_polynomials | ||
) |
Constructor. This takes the degree of the space, deg
from the finite element class, and n
, the number of polynomials for the space.
Definition at line 26 of file tensor_polynomials_base.cc.
|
default |
Move constructor.
|
default |
Copy constructor.
|
virtualdefault |
Virtual destructor. Makes sure that pointers to this class are deleted properly.
|
pure virtual |
Compute the value and the derivatives of the polynomials at unit_point
.
The size of the vectors must either be zero or equal n()
. In the first case, the function will not compute these values.
If you need values or derivatives of all polynomials then use this function, rather than using any of the compute_value
, compute_grad
or compute_grad_grad
functions, see below, in a loop over all tensor product polynomials.
Implemented in PolynomialsABF< dim >, PolynomialsBDM< dim >, PolynomialsBernardiRaugel< dim >, PolynomialsNedelec< dim >, PolynomialsRaviartThomas< dim >, and PolynomialsRT_Bubbles< dim >.
|
inline |
Return the number of polynomials.
Definition at line 157 of file tensor_polynomials_base.h.
|
inline |
Return the highest polynomial degree of polynomials represented by this class. A derived class may override this if its value is different from my_degree
.
Definition at line 166 of file tensor_polynomials_base.h.
|
pure virtual |
A sort of virtual copy constructor, this function returns a copy of the polynomial space object. Derived classes need to override the function here in this base class and return an object of the same type as the derived class.
Some places in the library, for example the constructors of FE_PolyTensor, need to make copies of polynomial spaces without knowing their exact type. They do so through this function.
Implemented in PolynomialsABF< dim >, PolynomialsBDM< dim >, PolynomialsBernardiRaugel< dim >, PolynomialsNedelec< dim >, PolynomialsRaviartThomas< dim >, and PolynomialsRT_Bubbles< dim >.
|
pure virtual |
Return the name of the space.
Implemented in PolynomialsABF< dim >, PolynomialsBDM< dim >, PolynomialsBernardiRaugel< dim >, PolynomialsNedelec< dim >, PolynomialsRaviartThomas< dim >, and PolynomialsRT_Bubbles< dim >.
|
private |
The highest polynomial degree of this functions represented by this object.
Definition at line 145 of file tensor_polynomials_base.h.
|
private |
The number of polynomials represented by this object.
Definition at line 150 of file tensor_polynomials_base.h.