Reference documentation for deal.II version 9.5.0
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Classes | Public Types | Public Member Functions | Static Public Member Functions | Public Attributes | Static Public Attributes | Protected Member Functions | Static Protected Member Functions | Protected Attributes | Private Types | Private Member Functions | Private Attributes | Static Private Attributes | Friends | List of all members
FiniteElement< dim, spacedim > Class Template Referenceabstract

#include <deal.II/fe/fe.h>

Inheritance diagram for FiniteElement< dim, spacedim >:
[legend]

Classes

class  InternalDataBase
 

Public Types

enum  Conformity {
  unknown = 0x00 , L2 = 0x01 , Hcurl = 0x02 , Hdiv = 0x04 ,
  H1 = Hcurl | Hdiv , H2 = 0x0e
}
 

Public Member Functions

 FiniteElement (const FiniteElementData< dim > &fe_data, const std::vector< bool > &restriction_is_additive_flags, const std::vector< ComponentMask > &nonzero_components)
 
 FiniteElement (FiniteElement< dim, spacedim > &&)=default
 
 FiniteElement (const FiniteElement< dim, spacedim > &)=default
 
virtual ~FiniteElement () override=default
 
std::pair< std::unique_ptr< FiniteElement< dim, spacedim > >, unsigned intoperator^ (const unsigned int multiplicity) const
 
virtual std::unique_ptr< FiniteElement< dim, spacedim > > clone () const =0
 
virtual std::string get_name () const =0
 
virtual bool operator== (const FiniteElement< dim, spacedim > &fe) const
 
bool operator!= (const FiniteElement< dim, spacedim > &) const
 
virtual std::size_t memory_consumption () const
 
template<class Archive >
void serialize (Archive &ar, const unsigned int version)
 
ReferenceCell reference_cell () const
 
unsigned int n_unique_2d_subobjects () const
 
unsigned int n_unique_faces () const
 
unsigned int n_dofs_per_vertex () const
 
unsigned int n_dofs_per_line () const
 
unsigned int n_dofs_per_quad (unsigned int face_no=0) const
 
unsigned int max_dofs_per_quad () const
 
unsigned int n_dofs_per_hex () const
 
unsigned int n_dofs_per_face (unsigned int face_no=0, unsigned int child=0) const
 
unsigned int max_dofs_per_face () const
 
unsigned int n_dofs_per_cell () const
 
template<int structdim>
unsigned int n_dofs_per_object (const unsigned int i=0) const
 
unsigned int n_components () const
 
unsigned int n_blocks () const
 
const BlockIndicesblock_indices () const
 
unsigned int tensor_degree () const
 
bool conforms (const Conformity) const
 
bool operator== (const FiniteElementData &) const
 
unsigned int get_first_line_index () const
 
unsigned int get_first_quad_index (const unsigned int quad_no=0) const
 
unsigned int get_first_hex_index () const
 
unsigned int get_first_face_line_index (const unsigned int face_no=0) const
 
unsigned int get_first_face_quad_index (const unsigned int face_no=0) const
 
Shape function access
virtual double shape_value (const unsigned int i, const Point< dim > &p) const
 
virtual double shape_value_component (const unsigned int i, const Point< dim > &p, const unsigned int component) const
 
virtual Tensor< 1, dim > shape_grad (const unsigned int i, const Point< dim > &p) const
 
virtual Tensor< 1, dim > shape_grad_component (const unsigned int i, const Point< dim > &p, const unsigned int component) const
 
virtual Tensor< 2, dim > shape_grad_grad (const unsigned int i, const Point< dim > &p) const
 
virtual Tensor< 2, dim > shape_grad_grad_component (const unsigned int i, const Point< dim > &p, const unsigned int component) const
 
virtual Tensor< 3, dim > shape_3rd_derivative (const unsigned int i, const Point< dim > &p) const
 
virtual Tensor< 3, dim > shape_3rd_derivative_component (const unsigned int i, const Point< dim > &p, const unsigned int component) const
 
virtual Tensor< 4, dim > shape_4th_derivative (const unsigned int i, const Point< dim > &p) const
 
virtual Tensor< 4, dim > shape_4th_derivative_component (const unsigned int i, const Point< dim > &p, const unsigned int component) const
 
virtual bool has_support_on_face (const unsigned int shape_index, const unsigned int face_index) const
 
Transfer and constraint matrices
virtual const FullMatrix< double > & get_restriction_matrix (const unsigned int child, const RefinementCase< dim > &refinement_case=RefinementCase< dim >::isotropic_refinement) const
 
virtual const FullMatrix< double > & get_prolongation_matrix (const unsigned int child, const RefinementCase< dim > &refinement_case=RefinementCase< dim >::isotropic_refinement) const
 
bool prolongation_is_implemented () const
 
bool isotropic_prolongation_is_implemented () const
 
bool restriction_is_implemented () const
 
bool isotropic_restriction_is_implemented () const
 
bool restriction_is_additive (const unsigned int index) const
 
const FullMatrix< double > & constraints (const ::internal::SubfaceCase< dim > &subface_case=::internal::SubfaceCase< dim >::case_isotropic) const
 
bool constraints_are_implemented (const ::internal::SubfaceCase< dim > &subface_case=::internal::SubfaceCase< dim >::case_isotropic) const
 
virtual bool hp_constraints_are_implemented () const
 
virtual void get_interpolation_matrix (const FiniteElement< dim, spacedim > &source, FullMatrix< double > &matrix) const
 
Functions to support hp-adaptivity
virtual void get_face_interpolation_matrix (const FiniteElement< dim, spacedim > &source, FullMatrix< double > &matrix, const unsigned int face_no=0) const
 
virtual void get_subface_interpolation_matrix (const FiniteElement< dim, spacedim > &source, const unsigned int subface, FullMatrix< double > &matrix, const unsigned int face_no=0) const
 
virtual std::vector< std::pair< unsigned int, unsigned int > > hp_vertex_dof_identities (const FiniteElement< dim, spacedim > &fe_other) const
 
virtual std::vector< std::pair< unsigned int, unsigned int > > hp_line_dof_identities (const FiniteElement< dim, spacedim > &fe_other) const
 
virtual std::vector< std::pair< unsigned int, unsigned int > > hp_quad_dof_identities (const FiniteElement< dim, spacedim > &fe_other, const unsigned int face_no=0) const
 
virtual FiniteElementDomination::Domination compare_for_domination (const FiniteElement< dim, spacedim > &fe_other, const unsigned int codim=0) const
 
Index computations
std::pair< unsigned int, unsigned intsystem_to_component_index (const unsigned int index) const
 
unsigned int component_to_system_index (const unsigned int component, const unsigned int index) const
 
std::pair< unsigned int, unsigned intface_system_to_component_index (const unsigned int index, const unsigned int face_no=0) const
 
unsigned int adjust_quad_dof_index_for_face_orientation (const unsigned int index, const unsigned int face_no, const bool face_orientation, const bool face_flip, const bool face_rotation) const
 
virtual unsigned int face_to_cell_index (const unsigned int face_dof_index, const unsigned int face, const bool face_orientation=true, const bool face_flip=false, const bool face_rotation=false) const
 
unsigned int adjust_line_dof_index_for_line_orientation (const unsigned int index, const bool line_orientation) const
 
const ComponentMaskget_nonzero_components (const unsigned int i) const
 
unsigned int n_nonzero_components (const unsigned int i) const
 
bool is_primitive () const
 
bool is_primitive (const unsigned int i) const
 
unsigned int n_base_elements () const
 
virtual const FiniteElement< dim, spacedim > & base_element (const unsigned int index) const
 
unsigned int element_multiplicity (const unsigned int index) const
 
const FiniteElement< dim, spacedim > & get_sub_fe (const ComponentMask &mask) const
 
virtual const FiniteElement< dim, spacedim > & get_sub_fe (const unsigned int first_component, const unsigned int n_selected_components) const
 
std::pair< std::pair< unsigned int, unsigned int >, unsigned intsystem_to_base_index (const unsigned int index) const
 
std::pair< std::pair< unsigned int, unsigned int >, unsigned intface_system_to_base_index (const unsigned int index, const unsigned int face_no=0) const
 
types::global_dof_index first_block_of_base (const unsigned int b) const
 
std::pair< unsigned int, unsigned intcomponent_to_base_index (const unsigned int component) const
 
std::pair< unsigned int, unsigned intblock_to_base_index (const unsigned int block) const
 
std::pair< unsigned int, types::global_dof_indexsystem_to_block_index (const unsigned int component) const
 
unsigned int component_to_block_index (const unsigned int component) const
 
Component and block matrices
ComponentMask component_mask (const FEValuesExtractors::Scalar &scalar) const
 
ComponentMask component_mask (const FEValuesExtractors::Vector &vector) const
 
ComponentMask component_mask (const FEValuesExtractors::SymmetricTensor< 2 > &sym_tensor) const
 
ComponentMask component_mask (const BlockMask &block_mask) const
 
BlockMask block_mask (const FEValuesExtractors::Scalar &scalar) const
 
BlockMask block_mask (const FEValuesExtractors::Vector &vector) const
 
BlockMask block_mask (const FEValuesExtractors::SymmetricTensor< 2 > &sym_tensor) const
 
BlockMask block_mask (const ComponentMask &component_mask) const
 
virtual std::pair< Table< 2, bool >, std::vector< unsigned int > > get_constant_modes () const
 
Support points and interpolation
const std::vector< Point< dim > > & get_unit_support_points () const
 
bool has_support_points () const
 
virtual Point< dim > unit_support_point (const unsigned int index) const
 
const std::vector< Point< dim - 1 > > & get_unit_face_support_points (const unsigned int face_no=0) const
 
bool has_face_support_points (const unsigned int face_no=0) const
 
virtual Point< dim - 1 > unit_face_support_point (const unsigned int index, const unsigned int face_no=0) const
 
const std::vector< Point< dim > > & get_generalized_support_points () const
 
bool has_generalized_support_points () const
 
GeometryPrimitive get_associated_geometry_primitive (const unsigned int cell_dof_index) const
 
virtual void convert_generalized_support_point_values_to_dof_values (const std::vector< Vector< double > > &support_point_values, std::vector< double > &nodal_values) const
 
Subscriptor functionality

Classes derived from Subscriptor provide a facility to subscribe to this object. This is mostly used by the SmartPointer class.

void subscribe (std::atomic< bool > *const validity, const std::string &identifier="") const
 
void unsubscribe (std::atomic< bool > *const validity, const std::string &identifier="") const
 
unsigned int n_subscriptions () const
 
template<typename StreamType >
void list_subscribers (StreamType &stream) const
 
void list_subscribers () const
 

Static Public Member Functions

static ::ExceptionBaseExcShapeFunctionNotPrimitive (int arg1)
 
static ::ExceptionBaseExcFENotPrimitive ()
 
static ::ExceptionBaseExcUnitShapeValuesDoNotExist ()
 
static ::ExceptionBaseExcFEHasNoSupportPoints ()
 
static ::ExceptionBaseExcEmbeddingVoid ()
 
static ::ExceptionBaseExcProjectionVoid ()
 
static ::ExceptionBaseExcWrongInterfaceMatrixSize (int arg1, int arg2)
 
static ::ExceptionBaseExcInterpolationNotImplemented ()
 
static ::ExceptionBaseExcInUse (int arg1, std::string arg2, std::string arg3)
 
static ::ExceptionBaseExcNoSubscriber (std::string arg1, std::string arg2)
 

Public Attributes

const unsigned int dofs_per_vertex
 
const unsigned int dofs_per_line
 
const unsigned int dofs_per_quad
 
const unsigned int dofs_per_hex
 
const unsigned int first_line_index
 
const unsigned int first_quad_index
 
const unsigned int first_hex_index
 
const unsigned int first_face_line_index
 
const unsigned int first_face_quad_index
 
const unsigned int dofs_per_face
 
const unsigned int dofs_per_cell
 
const unsigned int components
 
const unsigned int degree
 
const Conformity conforming_space
 
const BlockIndices block_indices_data
 

Static Public Attributes

static constexpr unsigned int space_dimension = spacedim
 
static constexpr unsigned int dimension = dim
 

Protected Member Functions

void reinit_restriction_and_prolongation_matrices (const bool isotropic_restriction_only=false, const bool isotropic_prolongation_only=false)
 
TableIndices< 2 > interface_constraints_size () const
 
virtual UpdateFlags requires_update_flags (const UpdateFlags update_flags) const =0
 
virtual std::unique_ptr< InternalDataBaseget_data (const UpdateFlags update_flags, const Mapping< dim, spacedim > &mapping, const Quadrature< dim > &quadrature, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const =0
 
virtual std::unique_ptr< InternalDataBaseget_face_data (const UpdateFlags update_flags, const Mapping< dim, spacedim > &mapping, const hp::QCollection< dim - 1 > &quadrature, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
 
virtual std::unique_ptr< InternalDataBaseget_face_data (const UpdateFlags update_flags, const Mapping< dim, spacedim > &mapping, const Quadrature< dim - 1 > &quadrature, internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
 
virtual std::unique_ptr< InternalDataBaseget_subface_data (const UpdateFlags update_flags, const Mapping< dim, spacedim > &mapping, const Quadrature< dim - 1 > &quadrature, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
 
virtual void fill_fe_values (const typename Triangulation< dim, spacedim >::cell_iterator &cell, const CellSimilarity::Similarity cell_similarity, const Quadrature< dim > &quadrature, const Mapping< dim, spacedim > &mapping, const typename Mapping< dim, spacedim >::InternalDataBase &mapping_internal, const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &mapping_data, const InternalDataBase &fe_internal, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const =0
 
virtual void fill_fe_face_values (const typename Triangulation< dim, spacedim >::cell_iterator &cell, const unsigned int face_no, const hp::QCollection< dim - 1 > &quadrature, const Mapping< dim, spacedim > &mapping, const typename Mapping< dim, spacedim >::InternalDataBase &mapping_internal, const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &mapping_data, const InternalDataBase &fe_internal, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
 
virtual void fill_fe_face_values (const typename Triangulation< dim, spacedim >::cell_iterator &cell, const unsigned int face_no, const Quadrature< dim - 1 > &quadrature, const Mapping< dim, spacedim > &mapping, const typename Mapping< dim, spacedim >::InternalDataBase &mapping_internal, const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &mapping_data, const InternalDataBase &fe_internal, internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
 
virtual void fill_fe_subface_values (const typename Triangulation< dim, spacedim >::cell_iterator &cell, const unsigned int face_no, const unsigned int sub_no, const Quadrature< dim - 1 > &quadrature, const Mapping< dim, spacedim > &mapping, const typename Mapping< dim, spacedim >::InternalDataBase &mapping_internal, const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &mapping_data, const InternalDataBase &fe_internal, ::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const =0
 

Static Protected Member Functions

static std::vector< unsigned intcompute_n_nonzero_components (const std::vector< ComponentMask > &nonzero_components)
 

Protected Attributes

std::vector< std::vector< FullMatrix< double > > > restriction
 
std::vector< std::vector< FullMatrix< double > > > prolongation
 
FullMatrix< double > interface_constraints
 
std::vector< Point< dim > > unit_support_points
 
std::vector< std::vector< Point< dim - 1 > > > unit_face_support_points
 
std::vector< Point< dim > > generalized_support_points
 
std::vector< std::vector< Point< dim - 1 > > > generalized_face_support_points
 
std::vector< Table< 2, int > > adjust_quad_dof_index_for_face_orientation_table
 
std::vector< intadjust_line_dof_index_for_line_orientation_table
 
std::vector< std::pair< unsigned int, unsigned int > > system_to_component_table
 
std::vector< std::vector< std::pair< unsigned int, unsigned int > > > face_system_to_component_table
 
std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > system_to_base_table
 
std::vector< std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > > face_system_to_base_table
 
BlockIndices base_to_block_indices
 
std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > component_to_base_table
 
const std::vector< boolrestriction_is_additive_flags
 
const std::vector< ComponentMasknonzero_components
 
const std::vector< unsigned intn_nonzero_components_table
 
const bool cached_primitivity
 

Private Types

using map_value_type = decltype(counter_map)::value_type
 
using map_iterator = decltype(counter_map)::iterator
 

Private Member Functions

void check_no_subscribers () const noexcept
 

Private Attributes

std::atomic< unsigned intcounter
 
std::map< std::string, unsigned intcounter_map
 
std::vector< std::atomic< bool > * > validity_pointers
 
const std::type_info * object_info
 
const ReferenceCell reference_cell_kind
 
const unsigned int number_of_unique_2d_subobjects
 
const unsigned int number_unique_faces
 
const std::vector< unsigned intn_dofs_on_quad
 
const unsigned int dofs_per_quad_max
 
const std::vector< unsigned intfirst_index_of_quads
 
const std::vector< unsigned intfirst_line_index_of_faces
 
const std::vector< unsigned intfirst_quad_index_of_faces
 
const std::vector< unsigned intn_dofs_on_face
 
const unsigned int dofs_per_face_max
 

Static Private Attributes

static std::mutex mutex
 

Friends

class InternalDataBase
 
class FEValuesBase< dim, spacedim >
 
class FEValues< dim, spacedim >
 
class FEFaceValues< dim, spacedim >
 
class FESubfaceValues< dim, spacedim >
 
class NonMatching::FEImmersedSurfaceValues< dim >
 
class FESystem< dim, spacedim >
 

Detailed Description

template<int dim, int spacedim = dim>
class FiniteElement< dim, spacedim >

This is the base class for finite elements in arbitrary dimensions. It declares the interface both in terms of member variables and public member functions through which properties of a concrete implementation of a finite element can be accessed. This interface generally consists of a number of groups of variables and functions that can roughly be delineated as follows:

The following sections discuss many of these concepts in more detail, and outline strategies by which concrete implementations of a finite element can provide the details necessary for a complete description of a finite element space.

As a general rule, there are three ways by which derived classes provide this information:

Nomenclature

Finite element classes have to define a large number of different properties describing a finite element space. The following subsections describe some nomenclature that will be used in the documentation below.

Components and blocks

Vector-valued finite element are elements used for systems of partial differential equations. Oftentimes, they are composed via the FESystem class (which is itself derived from the current class), but there are also non-composed elements that have multiple components (for example the FE_Nedelec and FE_RaviartThomas classes, among others). For any of these vector valued elements, individual shape functions may be nonzero in one or several components of the vector valued function. If the element is primitive, there is indeed a single component with a nonzero entry for each shape function. This component can be determined using the FiniteElement::system_to_component_index() function.

On the other hand, if there is at least one shape function that is nonzero in more than one vector component, then we call the entire element "non-primitive". The FiniteElement::get_nonzero_components() can then be used to determine which vector components of a shape function are nonzero. The number of nonzero components of a shape function is returned by FiniteElement::n_components(). Whether a shape function is non-primitive can be queried by FiniteElement::is_primitive().

Oftentimes, one may want to split linear system into blocks so that they reflect the structure of the underlying operator. This is typically not done based on vector components, but based on the use of blocks, and the result is then used to substructure objects of type BlockVector, BlockSparseMatrix, BlockMatrixArray, and so on. If you use non-primitive elements, you cannot determine the block number by FiniteElement::system_to_component_index(). Instead, you can use FiniteElement::system_to_block_index(). The number of blocks of a finite element can be determined by FiniteElement::n_blocks().

To better illustrate these concepts, let's consider the following example of the multi-component system

FESystem<dim> fe_basis(FE_Q<dim>(2), dim, FE_Q<dim>(1),1);
Definition fe_q.h:551

with dim=2. The resulting finite element has 3 components: two that come from the quadratic element and one from the linear element. If, for example, this system were used to discretize a problem in fluid dynamics then one could think of the first two components representing a vector-valued velocity field whereas the last one corresponds to the scalar pressure field. Without degree-of-freedom (DoF) renumbering this finite element will produce the following distribution of local DoFs:

DoF indices

Using the two functions FiniteElement::system_to_component_index() and FiniteElement::system_to_base_index() one can get the following information for each degree-of-freedom "i":

const unsigned int component =
fe_basis.system_to_component_index(i).first;
const unsigned int within_base =
fe_basis.system_to_component_index(i).second;
const unsigned int base =
fe_basis.system_to_base_index(i).first.first;
const unsigned int multiplicity =
fe_basis.system_to_base_index(i).first.second;
const unsigned int within_base_ =
fe_basis.system_to_base_index(i).second; // same as above

which will result in:

DoF Component Base element Shape function within base Multiplicity
0 0 0 0 0
1 1 0 0 1
2 2 1 0 0
3 0 0 1 0
4 1 0 1 1
5 2 1 1 0
6 0 0 2 0
7 1 0 2 1
8 2 1 2 0
9 0 0 3 0
10 1 0 3 1
11 2 1 3 0
12 0 0 4 0
13 1 0 4 1
14 0 0 5 0
15 1 0 5 1
16 0 0 6 0
17 1 0 6 1
18 0 0 7 0
19 1 0 7 1
20 0 0 8 0
21 1 0 8 1

What we see is the following: there are a total of 22 degrees-of-freedom on this element with components ranging from 0 to 2. Each DoF corresponds to one of the two base elements used to build FESystem : \(\mathbb Q_2\) or \(\mathbb Q_1\). Since FE_Q are primitive elements, we have a total of 9 distinct scalar-valued shape functions for the quadratic element and 4 for the linear element. Finally, for DoFs corresponding to the first base element multiplicity is either zero or one, meaning that we use the same scalar valued \(\mathbb Q_2\) for both \(x\) and \(y\) components of the velocity field \(\mathbb Q_2 \otimes \mathbb Q_2\). For DoFs corresponding to the second base element multiplicity is zero.

Support points

Finite elements are frequently defined by defining a polynomial space and a set of dual functionals. If these functionals involve point evaluations, then the element is "interpolatory" and it is possible to interpolate an arbitrary (but sufficiently smooth) function onto the finite element space by evaluating it at these points. We call these points "support points".

Most finite elements are defined by mapping from the reference cell to a concrete cell. Consequently, the support points are then defined on the reference ("unit") cell, see this glossary entry. The support points on a concrete cell can then be computed by mapping the unit support points, using the Mapping class interface and derived classes, typically via the FEValues class.

A typical code snippet to do so would look as follows:

Quadrature<dim> dummy_quadrature (fe.get_unit_support_points());
FEValues<dim> fe_values (mapping, fe, dummy_quadrature,
fe_values.reinit (cell);
Point<dim> mapped_point = fe_values.quadrature_point (i);
Definition point.h:112
@ update_quadrature_points
Transformed quadrature points.

Alternatively, the points can be transformed one-by-one:

const vector<Point<dim> > &unit_points =
fe.get_unit_support_points();
Point<dim> mapped_point =
mapping.transform_unit_to_real_cell (cell, unit_points[i]);
Note
Finite elements' implementation of the get_unit_support_points() function returns these points in the same order as shape functions. As a consequence, the quadrature points accessed above are also ordered in this way. The order of shape functions is typically documented in the class documentation of the various finite element classes.

Implementing finite element spaces in derived classes

The following sections provide some more guidance for implementing concrete finite element spaces in derived classes. This includes information that depends on the dimension for which you want to provide something, followed by a list of tools helping to generate information in concrete cases.

It is important to note that there is a number of intermediate classes that can do a lot of what is necessary for a complete description of finite element spaces. For example, the FE_Poly, FE_PolyTensor, and FE_PolyFace classes in essence build a complete finite element space if you only provide them with an abstract description of the polynomial space upon which you want to build an element. Using these intermediate classes typically makes implementing finite element descriptions vastly simpler.

As a general rule, if you want to implement an element, you will likely want to look at the implementation of other, similar elements first. Since many of the more complicated pieces of a finite element interface have to do with how they interact with mappings, quadrature, and the FEValues class, you will also want to read through the How Mapping, FiniteElement, and FEValues work together documentation module.

Interpolation matrices in one dimension

In one space dimension (i.e., for dim==1 and any value of spacedim), finite element classes implementing the interface of the current base class need only set the restriction and prolongation matrices that describe the interpolation of the finite element space on one cell to that of its parent cell, and to that on its children, respectively. The constructor of the current class in one dimension presets the interface_constraints matrix (used to describe hanging node constraints at the interface between cells of different refinement levels) to have size zero because there are no hanging nodes in 1d.

Interpolation matrices in two dimensions

In addition to the fields discussed above for 1d, a constraint matrix is needed to describe hanging node constraints if the finite element has degrees of freedom located on edges or vertices. These constraints are represented by an \(m\times n\)-matrix interface_constraints, where m is the number of degrees of freedom on the refined side without the corner vertices (those dofs on the middle vertex plus those on the two lines), and n is that of the unrefined side (those dofs on the two vertices plus those on the line). The matrix is thus a rectangular one. The \(m\times n\) size of the interface_constraints matrix can also be accessed through the interface_constraints_size() function.

The mapping of the dofs onto the indices of the matrix on the unrefined side is as follows: let \(d_v\) be the number of dofs on a vertex, \(d_l\) that on a line, then \(n=0...d_v-1\) refers to the dofs on vertex zero of the unrefined line, \(n=d_v...2d_v-1\) to those on vertex one, \(n=2d_v...2d_v+d_l-1\) to those on the line.

Similarly, \(m=0...d_v-1\) refers to the dofs on the middle vertex of the refined side (vertex one of child line zero, vertex zero of child line one), \(m=d_v...d_v+d_l-1\) refers to the dofs on child line zero, \(m=d_v+d_l...d_v+2d_l-1\) refers to the dofs on child line one. Please note that we do not need to reserve space for the dofs on the end vertices of the refined lines, since these must be mapped one-to-one to the appropriate dofs of the vertices of the unrefined line.

Through this construction, the degrees of freedom on the child faces are constrained to the degrees of freedom on the parent face. The information so provided is typically consumed by the DoFTools::make_hanging_node_constraints() function.

Note
The hanging node constraints described by these matrices are only relevant to the case where the same finite element space is used on neighboring (but differently refined) cells. The case that the finite element spaces on different sides of a face are different, i.e., the \(hp\) case (see hp-finite element support) is handled by separate functions. See the FiniteElement::get_face_interpolation_matrix() and FiniteElement::get_subface_interpolation_matrix() functions.

Interpolation matrices in three dimensions

For the interface constraints, the 3d case is similar to the 2d case. The numbering for the indices \(n\) on the mother face is obvious and keeps to the usual numbering of degrees of freedom on quadrilaterals.

The numbering of the degrees of freedom on the interior of the refined faces for the index \(m\) is as follows: let \(d_v\) and \(d_l\) be as above, and \(d_q\) be the number of degrees of freedom per quadrilateral (and therefore per face), then \(m=0...d_v-1\) denote the dofs on the vertex at the center, \(m=d_v...5d_v-1\) for the dofs on the vertices at the center of the bounding lines of the quadrilateral, \(m=5d_v..5d_v+4*d_l-1\) are for the degrees of freedom on the four lines connecting the center vertex to the outer boundary of the mother face, \(m=5d_v+4*d_l...5d_v+4*d_l+8*d_l-1\) for the degrees of freedom on the small lines surrounding the quad, and \(m=5d_v+12*d_l...5d_v+12*d_l+4*d_q-1\) for the dofs on the four child faces. Note the direction of the lines at the boundary of the quads, as shown below.

The order of the twelve lines and the four child faces can be extracted from the following sketch, where the overall order of the different dof groups is depicted:

*    *--15--4--16--*
*    |      |      |
*    10 19  6  20  12
*    |      |      |
*    1--7---0--8---2
*    |      |      |
*    9  17  5  18  11
*    |      |      |
*    *--13--3--14--*
* 

The numbering of vertices and lines, as well as the numbering of children within a line is consistent with the one described in Triangulation. Therefore, this numbering is seen from the outside and inside, respectively, depending on the face.

The three-dimensional case has a few pitfalls available for derived classes that want to implement constraint matrices. Consider the following case:

*          *-------*
*         /       /|
*        /       / |
*       /       /  |
*      *-------*   |
*      |       |   *-------*
*      |       |  /       /|
*      |   1   | /       / |
*      |       |/       /  |
*      *-------*-------*   |
*      |       |       |   *
*      |       |       |  /
*      |   2   |   3   | /
*      |       |       |/
*      *-------*-------*
* 

Now assume that we want to refine cell 2. We will end up with two faces with hanging nodes, namely the faces between cells 1 and 2, as well as between cells 2 and 3. Constraints have to be applied to the degrees of freedom on both these faces. The problem is that there is now an edge (the top right one of cell 2) which is part of both faces. The hanging node(s) on this edge are therefore constrained twice, once from both faces. To be meaningful, these constraints of course have to be consistent: both faces have to constrain the hanging nodes on the edge to the same nodes on the coarse edge (and only on the edge, as there can then be no constraints to nodes on the rest of the face), and they have to do so with the same weights. This is sometimes tricky since the nodes on the edge may have different local numbers.

For the constraint matrix this means the following: if a degree of freedom on one edge of a face is constrained by some other nodes on the same edge with some weights, then the weights have to be exactly the same as those for constrained nodes on the three other edges with respect to the corresponding nodes on these edges. If this isn't the case, you will get into trouble with the AffineConstraints class that is the primary consumer of the constraint information: while that class is able to handle constraints that are entered more than once (as is necessary for the case above), it insists that the weights are exactly the same.

Using this scheme, child face degrees of freedom are constrained against parent face degrees of freedom that contain those on the edges of the parent face; it is possible that some of them are in turn constrained themselves, leading to longer chains of constraints that the AffineConstraints class will eventually have to sort out. (The constraints described above are used by the DoFTools::make_hanging_node_constraints() function that constructs an AffineConstraints object.) However, this is of no concern for the FiniteElement and derived classes since they only act locally on one cell and its immediate neighbor, and do not see the bigger picture. The hp_paper details how such chains are handled in practice.

Helper functions

Construction of a finite element and computation of the matrices described above is often a tedious task, in particular if it has to be performed for several dimensions. Most of this work can be avoided by using the intermediate classes already mentioned above (e.g., FE_Poly, FE_PolyTensor, etc). Other tasks can be automated by some of the functions in namespace FETools.

Computing the correct basis from a set of linearly independent functions

First, it may already be difficult to compute the basis of shape functions for arbitrary order and dimension. On the other hand, if the node values are given, then the duality relation between node functionals and basis functions defines the basis. As a result, the shape function space may be defined from a set of linearly independent functions, such that the actual finite element basis is computed from linear combinations of them. The coefficients of these combinations are determined by the duality of node values and form a matrix.

Using this matrix allows the construction of the basis of shape functions in two steps.

  1. Define the space of shape functions using an arbitrary basis wj and compute the matrix M of node functionals Ni applied to these basis functions, such that its entries are mij = Ni(wj).

  2. Compute the basis vj of the finite element shape function space by applying M-1 to the basis wj.

The matrix M may be computed with FETools::compute_node_matrix(). This function relies on the existence of generalized_support_points and FiniteElement::convert_generalized_support_point_values_to_dof_values() (see the glossary entry on generalized support points for more information). With this, one can then use the following piece of code in the constructor of a class derived from FiniteElement to compute the \(M\) matrix:

this->inverse_node_matrix.reinit(this->n_dofs_per_cell(),
this->n_dofs_per_cell()); this->inverse_node_matrix.invert(M);
unsigned int n_dofs_per_cell() const
FullMatrix< double > compute_node_matrix(const FiniteElement< dim, spacedim > &fe)

Don't forget to make sure that unit_support_points or generalized_support_points are initialized before this!

Computing prolongation matrices

Once you have shape functions, you can define matrices that transfer data from one cell to its children or the other way around. This is a common operation in multigrid, of course, but is also used when interpolating the solution from one mesh to another after mesh refinement, as well as in the definition of some error estimators.

To define the prolongation matrices, i.e., those matrices that describe the transfer of a finite element field from one cell to its children, implementations of finite elements can either fill the prolongation array by hand, or can call FETools::compute_embedding_matrices().

In the latter case, all that is required is the following piece of code:

for (unsigned int c=0; c<GeometryInfo<dim>::max_children_per_cell; ++c)
this->prolongation[c].reinit (this->n_dofs_per_cell(),
this->n_dofs_per_cell());
std::vector< std::vector< FullMatrix< double > > > prolongation
Definition fe.h:2416
void compute_embedding_matrices(const FiniteElement< dim, spacedim > &fe, std::vector< std::vector< FullMatrix< number > > > &matrices, const bool isotropic_only=false, const double threshold=1.e-12)

As in this example, prolongation is almost always implemented via embedding, i.e., the nodal values of the function on the children may be different from the nodal values of the function on the parent cell, but as a function of \(\mathbf x\in{\mathbb R}^\text{spacedim}\), the finite element field on the child is the same as on the parent.

Computing restriction matrices

The opposite operation, restricting a finite element function defined on the children to the parent cell is typically implemented by interpolating the finite element function on the children to the nodal values of the parent cell. In deal.II, the restriction operation is implemented as a loop over the children of a cell that each apply a matrix to the vector of unknowns on that child cell (these matrices are stored in restriction and are accessed by get_restriction_matrix()). The operation that then needs to be implemented turns out to be surprisingly difficult to describe, but is instructive to describe because it also defines the meaning of the restriction_is_additive_flags array (accessed via the restriction_is_additive() function).

To give a concrete example, assume we use a \(Q_1\) element in 1d, and that on each of the parent and child cells degrees of freedom are (locally and globally) numbered as follows:

meshes: *-------* *---*---*
local DoF numbers: 0 1 0 1|0 1
global DoF numbers: 0 1 0 1 2

Then we want the restriction operation to take the value of the zeroth DoF on child 0 as the value of the zeroth DoF on the parent, and take the value of the first DoF on child 1 as the value of the first DoF on the parent. Ideally, we would like to write this follows

\[ U^\text{coarse}|_\text{parent} = \sum_{\text{child}=0}^1 R_\text{child} U^\text{fine}|_\text{child} \]

where \(U^\text{fine}|_\text{child=0}=(U^\text{fine}_0,U^\text{fine}_1)^T\) and \(U^\text{fine}|_\text{child=1}=(U^\text{fine}_1,U^\text{fine}_2)^T\). Writing the requested operation like this would here be possible by choosing

\[ R_0 = \left(\begin{matrix}1 & 0 \\ 0 & 0\end{matrix}\right), \qquad\qquad R_1 = \left(\begin{matrix}0 & 0 \\ 0 & 1\end{matrix}\right). \]

However, this approach already fails if we go to a \(Q_2\) element with the following degrees of freedom:

meshes: *-------* *----*----*
local DoF numbers: 0 2 1 0 2 1|0 2 1
global DoF numbers: 0 2 1 0 2 1 4 3

Writing things as the sum over matrix operations as above would not easily work because we have to add nonzero values to \(U^\text{coarse}_2\) twice, once for each child.

Consequently, restriction is typically implemented as a concatenation operation. I.e., we first compute the individual restrictions from each child,

\[ \tilde U^\text{coarse}_\text{child} = R_\text{child} U^\text{fine}|_\text{child}, \]

and then compute the values of \(U^\text{coarse}|_\text{parent}\) with the following code:

for (unsigned int child=0; child<cell->n_children(); ++child)
for (unsigned int i=0; i<dofs_per_cell; ++i)
if (U_tilde_coarse[child][i] != 0)
U_coarse_on_parent[i] = U_tilde_coarse[child][i];
const unsigned int dofs_per_cell
Definition fe_data.h:437

In other words, each nonzero element of \(\tilde U^\text{coarse}_\text{child}\) overwrites, rather than adds to the corresponding element of \(U^\text{coarse}|_\text{parent}\). This typically also implies that the restriction matrices from two different cells should agree on a value for coarse degrees of freedom that they both want to touch (otherwise the result would depend on the order in which we loop over children, which would be unreasonable because the order of children is an otherwise arbitrary convention). For example, in the example above, the restriction matrices will be

\[ R_0 = \left(\begin{matrix}1 & 0 & 0 \\ 0 & 0 & 0 \\ 0 & 1 & 0 \end{matrix}\right), \qquad\qquad R_1 = \left(\begin{matrix}0 & 0 & 0 \\ 0 & 1 & 0 \\ 1 & 0 & 0 \end{matrix}\right), \]

and the compatibility condition is the \(R_{0,21}=R_{1,20}\) because they both indicate that \(U^\text{coarse}|_\text{parent,2}\) should be set to one times \(U^\text{fine}|_\text{child=0,1}\) and \(U^\text{fine}|_\text{child=1,0}\).

Unfortunately, not all finite elements allow to write the restriction operation in this way. For example, for the piecewise constant FE_DGQ(0) element, the value of the finite element field on the parent cell can not be determined by interpolation from the children. Rather, the only reasonable choice is to take it as the average value between the children – so we are back to the sum operation, rather than the concatenation. Further thought shows that whether restriction should be additive or not is a property of the individual shape function, not of the finite element as a whole. Consequently, the FiniteElement::restriction_is_additive() function returns whether a particular shape function should act via concatenation (a return value of false) or via addition (return value of true), and the correct code for the overall operation is then as follows (and as, in fact, implemented in DoFAccessor::get_interpolated_dof_values()):

for (unsigned int child=0; child<cell->n_children(); ++child)
for (unsigned int i=0; i<dofs_per_cell; ++i)
if (fe.restriction_is_additive(i) == true)
U_coarse_on_parent[i] += U_tilde_coarse[child][i];
else
if (U_tilde_coarse[child][i] != 0)
U_coarse_on_parent[i] = U_tilde_coarse[child][i];
Computing interface_constraints

Constraint matrices can be computed semi-automatically using FETools::compute_face_embedding_matrices(). This function computes the representation of the coarse mesh functions by fine mesh functions for each child of a face separately. These matrices must be convoluted into a single rectangular constraint matrix, eliminating degrees of freedom on common vertices and edges as well as on the coarse grid vertices. See the discussion above for details of this numbering.

Definition at line 655 of file fe.h.

Member Typedef Documentation

◆ map_value_type

using Subscriptor::map_value_type = decltype(counter_map)::value_type
privateinherited

The data type used in counter_map.

Definition at line 230 of file subscriptor.h.

◆ map_iterator

using Subscriptor::map_iterator = decltype(counter_map)::iterator
privateinherited

The iterator type used in counter_map.

Definition at line 235 of file subscriptor.h.

Member Enumeration Documentation

◆ Conformity

template<int dim>
enum FiniteElementData::Conformity
inherited

Enumerator for the different types of continuity a finite element may have. Continuity is measured by the Sobolev space containing the constructed finite element space and is also called this way.

Note that certain continuities may imply others. For instance, a function in H1 is in Hcurl and Hdiv as well.

If you are interested in continuity in the classical sense, then the following relations hold:

  1. H1 implies that the function is continuous over cell boundaries.

  2. H2 implies that the function is continuously differentiable over cell boundaries.

  3. L2 indicates that the element is discontinuous. Since discontinuous elements have no topological couplings between grid cells and code may actually depend on this property, L2 conformity is handled in a special way in the sense that it is not implied by any higher conformity.

In order to test if a finite element conforms to a certain space, use FiniteElementData<dim>::conforms().

Enumerator
unknown 

Indicates incompatible continuities of a system.

L2 

Discontinuous elements. See above!

Hcurl 

Conformity with the space Hcurl (continuous tangential component of a vector field)

Hdiv 

Conformity with the space Hdiv (continuous normal component of a vector field)

H1 

Conformity with the space H1 (continuous)

H2 

Conformity with the space H2 (continuously differentiable)

Definition at line 262 of file fe_data.h.

Constructor & Destructor Documentation

◆ FiniteElement() [1/3]

template<int dim, int spacedim = dim>
FiniteElement< dim, spacedim >::FiniteElement ( const FiniteElementData< dim > &  fe_data,
const std::vector< bool > &  restriction_is_additive_flags,
const std::vector< ComponentMask > &  nonzero_components 
)

Constructor: initialize the fields of this base class of all finite elements.

Parameters
[in]fe_dataAn object that stores identifying (typically integral) information about the element to be constructed. In particular, this object will contain data such as the number of degrees of freedom per cell (and per vertex, line, etc), the number of vector components, etc. This argument is used to initialize the base class of the current object under construction.
[in]restriction_is_additive_flagsA vector of size dofs_per_cell (or of size one, see below) that for each shape function states whether the shape function is additive or not. The meaning of these flags is described in the section on restriction matrices in the general documentation of this class.
[in]nonzero_componentsA vector of size dofs_per_cell (or of size one, see below) that for each shape function provides a ComponentMask (of size fe_data.n_components()) that indicates in which vector components this shape function is nonzero (after mapping the shape function to the real cell). For "primitive" shape functions, this component mask will have a single entry (see GlossPrimitive for more information about primitive elements). On the other hand, for elements such as the Raviart-Thomas or Nedelec elements, shape functions are nonzero in more than one vector component (after mapping to the real cell) and the given component mask will contain more than one entry. (For these two elements, all entries will in fact be set, but this would not be the case if you couple a FE_RaviartThomas and a FE_Nedelec together into a FESystem.)
Precondition
restriction_is_additive_flags.size() == dofs_per_cell, or restriction_is_additive_flags.size() == 1. In the latter case, the array is simply interpreted as having size dofs_per_cell where each element has the same value as the single element given.
nonzero_components.size() == dofs_per_cell, or nonzero_components.size() == 1. In the latter case, the array is simply interpreted as having size dofs_per_cell where each element equals the component mask provided in the single element given.

◆ FiniteElement() [2/3]

template<int dim, int spacedim = dim>
FiniteElement< dim, spacedim >::FiniteElement ( FiniteElement< dim, spacedim > &&  )
default

Move constructor.

◆ FiniteElement() [3/3]

template<int dim, int spacedim = dim>
FiniteElement< dim, spacedim >::FiniteElement ( const FiniteElement< dim, spacedim > &  )
default

Copy constructor.

◆ ~FiniteElement()

template<int dim, int spacedim = dim>
virtual FiniteElement< dim, spacedim >::~FiniteElement ( )
overridevirtualdefault

Virtual destructor. Makes sure that pointers to this class are deleted properly.

Member Function Documentation

◆ operator^()

template<int dim, int spacedim = dim>
std::pair< std::unique_ptr< FiniteElement< dim, spacedim > >, unsigned int > FiniteElement< dim, spacedim >::operator^ ( const unsigned int  multiplicity) const

Creates information for creating a FESystem with this class as base element and with multiplicity multiplicity. In particular, the return type of this function can be used in the constructor for a FESystem object. This function calls clone() and hence creates a copy of the current object.

◆ clone()

template<int dim, int spacedim = dim>
virtual std::unique_ptr< FiniteElement< dim, spacedim > > FiniteElement< dim, spacedim >::clone ( ) const
pure virtual

A sort of virtual copy constructor, this function returns a copy of the finite element 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 FESystem as well as the hp::FECollection class, need to make copies of finite elements without knowing their exact type. They do so through this function.

Implemented in FE_ABF< dim >, FE_BDM< dim >, FE_BernardiRaugel< dim >, FE_Bernstein< dim, spacedim >, FE_DGVector< PolynomialType, dim, spacedim >, FE_DGVector< PolynomialsBDM< dim >, dim, dim >, FE_DGVector< PolynomialsNedelec< dim >, dim, dim >, FE_DGVector< PolynomialsRaviartThomas< dim >, dim, dim >, FE_DGP< dim, spacedim >, FE_DGPMonomial< dim >, FE_DGPNonparametric< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_DGQArbitraryNodes< dim, spacedim >, FE_DGQLegendre< dim, spacedim >, FE_DGQHermite< dim, spacedim >, FE_Enriched< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_FaceQ< 1, spacedim >, FE_FaceP< dim, spacedim >, FE_Nedelec< dim >, FE_NedelecSZ< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_P1NC, FE_PyramidP< dim, spacedim >, FE_PyramidDGP< dim, spacedim >, FE_Q< dim, spacedim >, FE_Q< dim, dim >, FE_Q_Bubbles< dim, spacedim >, FE_Q_DG0< dim, spacedim >, FE_Q_Hierarchical< dim >, FE_Q_iso_Q1< dim, spacedim >, FE_RannacherTurek< dim >, FE_RaviartThomas< dim >, FE_RaviartThomasNodal< dim >, FE_RT_Bubbles< dim >, FE_SimplexP< dim, spacedim >, FE_SimplexDGP< dim, spacedim >, FE_SimplexP_Bubbles< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, FE_TraceQ< dim, spacedim >, FE_WedgeP< dim, spacedim >, and FE_WedgeDGP< dim, spacedim >.

◆ get_name()

template<int dim, int spacedim = dim>
virtual std::string FiniteElement< dim, spacedim >::get_name ( ) const
pure virtual

Return a string that uniquely identifies a finite element. The general convention is that this is the class name, followed by the dimension in angle brackets, and the polynomial degree and whatever else is necessary in parentheses. For example, FE_Q<2>(3) is the value returned for a cubic element in 2d.

Systems of elements have their own naming convention, see the FESystem class.

Implemented in FE_ABF< dim >, FE_BDM< dim >, FE_BernardiRaugel< dim >, FE_Bernstein< dim, spacedim >, FE_DGVector< PolynomialType, dim, spacedim >, FE_DGVector< PolynomialsBDM< dim >, dim, dim >, FE_DGVector< PolynomialsNedelec< dim >, dim, dim >, FE_DGVector< PolynomialsRaviartThomas< dim >, dim, dim >, FE_DGNedelec< dim, spacedim >, FE_DGRaviartThomas< dim, spacedim >, FE_DGBDM< dim, spacedim >, FE_DGP< dim, spacedim >, FE_DGPMonomial< dim >, FE_DGPNonparametric< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_DGQArbitraryNodes< dim, spacedim >, FE_DGQLegendre< dim, spacedim >, FE_DGQHermite< dim, spacedim >, FE_Enriched< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_FaceQ< 1, spacedim >, FE_FaceP< dim, spacedim >, FE_FaceP< 1, spacedim >, FE_Nedelec< dim >, FE_NedelecSZ< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_P1NC, FE_PyramidP< dim, spacedim >, FE_PyramidDGP< dim, spacedim >, FE_Q< dim, spacedim >, FE_Q< dim, dim >, FE_Q_Bubbles< dim, spacedim >, FE_Q_DG0< dim, spacedim >, FE_Q_Hierarchical< dim >, FE_Q_iso_Q1< dim, spacedim >, FE_RannacherTurek< dim >, FE_RaviartThomas< dim >, FE_RaviartThomasNodal< dim >, FE_RT_Bubbles< dim >, FE_SimplexP< dim, spacedim >, FE_SimplexDGP< dim, spacedim >, FE_SimplexP_Bubbles< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, FE_TraceQ< dim, spacedim >, FE_TraceQ< 1, spacedim >, FE_WedgeP< dim, spacedim >, and FE_WedgeDGP< dim, spacedim >.

◆ shape_value()

template<int dim, int spacedim = dim>
virtual double FiniteElement< dim, spacedim >::shape_value ( const unsigned int  i,
const Point< dim > &  p 
) const
virtual

Return the value of the ith shape function at the point p. p is a point on the reference element. If the finite element is vector-valued, then return the value of the only non-zero component of the vector value of this shape function. If the shape function has more than one non-zero component (which we refer to with the term non-primitive), then derived classes implementing this function should throw an exception of type ExcShapeFunctionNotPrimitive. In that case, use the shape_value_component() function.

Implementations of this function should throw an exception of type ExcUnitShapeValuesDoNotExist if the shape functions of the FiniteElement under consideration depend on the shape of the cell in real space, i.e., if the shape functions are not defined by mapping from the reference cell. Some non-conforming elements are defined this way, as is the FE_DGPNonparametric class, to name just one example.

The default implementation of this virtual function does exactly this, i.e., it simply throws an exception of type ExcUnitShapeValuesDoNotExist.

Reimplemented in FE_DGPNonparametric< dim, spacedim >, FE_Enriched< dim, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_value_component()

template<int dim, int spacedim = dim>
virtual double FiniteElement< dim, spacedim >::shape_value_component ( const unsigned int  i,
const Point< dim > &  p,
const unsigned int  component 
) const
virtual

Just like for shape_value(), but this function will be called when the shape function has more than one non-zero vector component. In that case, this function should return the value of the component-th vector component of the ith shape function at point p.

Reimplemented in FE_DGPNonparametric< dim, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_grad()

template<int dim, int spacedim = dim>
virtual Tensor< 1, dim > FiniteElement< dim, spacedim >::shape_grad ( const unsigned int  i,
const Point< dim > &  p 
) const
virtual

Return the gradient of the ith shape function at the point p. p is a point on the reference element, and likewise the gradient is the gradient on the unit cell with respect to unit cell coordinates. If the finite element is vector-valued, then return the value of the only non-zero component of the vector value of this shape function. If the shape function has more than one non-zero component (which we refer to with the term non-primitive), then derived classes implementing this function should throw an exception of type ExcShapeFunctionNotPrimitive. In that case, use the shape_grad_component() function.

Implementations of this function should throw an exception of type ExcUnitShapeValuesDoNotExist if the shape functions of the FiniteElement under consideration depend on the shape of the cell in real space, i.e., if the shape functions are not defined by mapping from the reference cell. Some non-conforming elements are defined this way, as is the FE_DGPNonparametric class, to name just one example.

The default implementation of this virtual function does exactly this, i.e., it simply throws an exception of type ExcUnitShapeValuesDoNotExist.

Reimplemented in FE_DGPNonparametric< dim, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_grad_component()

template<int dim, int spacedim = dim>
virtual Tensor< 1, dim > FiniteElement< dim, spacedim >::shape_grad_component ( const unsigned int  i,
const Point< dim > &  p,
const unsigned int  component 
) const
virtual

Just like for shape_grad(), but this function will be called when the shape function has more than one non-zero vector component. In that case, this function should return the gradient of the component-th vector component of the ith shape function at point p.

Reimplemented in FE_DGPNonparametric< dim, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_grad_grad()

template<int dim, int spacedim = dim>
virtual Tensor< 2, dim > FiniteElement< dim, spacedim >::shape_grad_grad ( const unsigned int  i,
const Point< dim > &  p 
) const
virtual

Return the tensor of second derivatives of the ith shape function at point p on the unit cell. The derivatives are derivatives on the unit cell with respect to unit cell coordinates. If the finite element is vector-valued, then return the value of the only non-zero component of the vector value of this shape function. If the shape function has more than one non-zero component (which we refer to with the term non-primitive), then derived classes implementing this function should throw an exception of type ExcShapeFunctionNotPrimitive. In that case, use the shape_grad_grad_component() function.

Implementations of this function should throw an exception of type ExcUnitShapeValuesDoNotExist if the shape functions of the FiniteElement under consideration depend on the shape of the cell in real space, i.e., if the shape functions are not defined by mapping from the reference cell. Some non-conforming elements are defined this way, as is the FE_DGPNonparametric class, to name just one example.

The default implementation of this virtual function does exactly this, i.e., it simply throws an exception of type ExcUnitShapeValuesDoNotExist.

Reimplemented in FE_DGPNonparametric< dim, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_grad_grad_component()

template<int dim, int spacedim = dim>
virtual Tensor< 2, dim > FiniteElement< dim, spacedim >::shape_grad_grad_component ( const unsigned int  i,
const Point< dim > &  p,
const unsigned int  component 
) const
virtual

Just like for shape_grad_grad(), but this function will be called when the shape function has more than one non-zero vector component. In that case, this function should return the gradient of the component-th vector component of the ith shape function at point p.

Reimplemented in FE_DGPNonparametric< dim, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_3rd_derivative()

template<int dim, int spacedim = dim>
virtual Tensor< 3, dim > FiniteElement< dim, spacedim >::shape_3rd_derivative ( const unsigned int  i,
const Point< dim > &  p 
) const
virtual

Return the tensor of third derivatives of the ith shape function at point p on the unit cell. The derivatives are derivatives on the unit cell with respect to unit cell coordinates. If the finite element is vector-valued, then return the value of the only non-zero component of the vector value of this shape function. If the shape function has more than one non-zero component (which we refer to with the term non-primitive), then derived classes implementing this function should throw an exception of type ExcShapeFunctionNotPrimitive. In that case, use the shape_3rd_derivative_component() function.

Implementations of this function should throw an exception of type ExcUnitShapeValuesDoNotExist if the shape functions of the FiniteElement under consideration depend on the shape of the cell in real space, i.e., if the shape functions are not defined by mapping from the reference cell. Some non-conforming elements are defined this way, as is the FE_DGPNonparametric class, to name just one example.

The default implementation of this virtual function does exactly this, i.e., it simply throws an exception of type ExcUnitShapeValuesDoNotExist.

Reimplemented in FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_3rd_derivative_component()

template<int dim, int spacedim = dim>
virtual Tensor< 3, dim > FiniteElement< dim, spacedim >::shape_3rd_derivative_component ( const unsigned int  i,
const Point< dim > &  p,
const unsigned int  component 
) const
virtual

Just like for shape_3rd_derivative(), but this function will be called when the shape function has more than one non-zero vector component. In that case, this function should return the gradient of the component- th vector component of the ith shape function at point p.

Reimplemented in FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_4th_derivative()

template<int dim, int spacedim = dim>
virtual Tensor< 4, dim > FiniteElement< dim, spacedim >::shape_4th_derivative ( const unsigned int  i,
const Point< dim > &  p 
) const
virtual

Return the tensor of fourth derivatives of the ith shape function at point p on the unit cell. The derivatives are derivatives on the unit cell with respect to unit cell coordinates. If the finite element is vector-valued, then return the value of the only non-zero component of the vector value of this shape function. If the shape function has more than one non-zero component (which we refer to with the term non-primitive), then derived classes implementing this function should throw an exception of type ExcShapeFunctionNotPrimitive. In that case, use the shape_4th_derivative_component() function.

Implementations of this function should throw an exception of type ExcUnitShapeValuesDoNotExist if the shape functions of the FiniteElement under consideration depend on the shape of the cell in real space, i.e., if the shape functions are not defined by mapping from the reference cell. Some non-conforming elements are defined this way, as is the FE_DGPNonparametric class, to name just one example.

The default implementation of this virtual function does exactly this, i.e., it simply throws an exception of type ExcUnitShapeValuesDoNotExist.

Reimplemented in FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ shape_4th_derivative_component()

template<int dim, int spacedim = dim>
virtual Tensor< 4, dim > FiniteElement< dim, spacedim >::shape_4th_derivative_component ( const unsigned int  i,
const Point< dim > &  p,
const unsigned int  component 
) const
virtual

Just like for shape_4th_derivative(), but this function will be called when the shape function has more than one non-zero vector component. In that case, this function should return the gradient of the component- th vector component of the ith shape function at point p.

Reimplemented in FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ has_support_on_face()

template<int dim, int spacedim = dim>
virtual bool FiniteElement< dim, spacedim >::has_support_on_face ( const unsigned int  shape_index,
const unsigned int  face_index 
) const
virtual

◆ get_restriction_matrix()

template<int dim, int spacedim = dim>
virtual const FullMatrix< double > & FiniteElement< dim, spacedim >::get_restriction_matrix ( const unsigned int  child,
const RefinementCase< dim > &  refinement_case = RefinementCase< dim >::isotropic_refinement 
) const
virtual

Return the matrix that describes restricting a finite element field from the given child (as obtained by the given refinement_case) to the parent cell. The interpretation of the returned matrix depends on what restriction_is_additive() returns for each shape function.

Row and column indices are related to coarse grid and fine grid spaces, respectively, consistent with the definition of the associated operator.

If projection matrices are not implemented in the derived finite element class, this function aborts with an exception of type FiniteElement::ExcProjectionVoid. You can check whether this would happen by first calling the restriction_is_implemented() or the isotropic_restriction_is_implemented() function.

Reimplemented in FE_Q_Bubbles< dim, spacedim >, FE_Bernstein< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Enriched< dim, spacedim >, FE_Nedelec< dim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FE_RaviartThomasNodal< dim >, FE_SimplexPoly< dim, spacedim >, FE_SimplexPoly< dim, dim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ get_prolongation_matrix()

template<int dim, int spacedim = dim>
virtual const FullMatrix< double > & FiniteElement< dim, spacedim >::get_prolongation_matrix ( const unsigned int  child,
const RefinementCase< dim > &  refinement_case = RefinementCase< dim >::isotropic_refinement 
) const
virtual

Prolongation/embedding matrix between grids.

The identity operator from a coarse grid space into a fine grid space (where both spaces are identified as functions defined on the parent and child cells) is associated with a matrix P that maps the corresponding representations of these functions in terms of their nodal values. The restriction of this matrix P_i to a single child cell is returned here.

The matrix P is the concatenation, not the sum of the cell matrices P_i. That is, if the same non-zero entry j,k exists in two different child matrices P_i, the value should be the same in both matrices and it is copied into the matrix P only once.

Row and column indices are related to fine grid and coarse grid spaces, respectively, consistent with the definition of the associated operator.

These matrices are used by routines assembling the prolongation matrix for multi-level methods. Upon assembling the transfer matrix between cells using this matrix array, zero elements in the prolongation matrix are discarded and will not fill up the transfer matrix.

If prolongation matrices are not implemented in the derived finite element class, this function aborts with an exception of type FiniteElement::ExcEmbeddingVoid. You can check whether this would happen by first calling the prolongation_is_implemented() or the isotropic_prolongation_is_implemented() function.

Reimplemented in FE_Q_Bubbles< dim, spacedim >, FE_Bernstein< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Enriched< dim, spacedim >, FE_Nedelec< dim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FE_Q_Hierarchical< dim >, FE_RaviartThomasNodal< dim >, FE_SimplexPoly< dim, spacedim >, FE_SimplexPoly< dim, dim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ prolongation_is_implemented()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::prolongation_is_implemented ( ) const

Return whether this element implements its prolongation matrices. The return value also indicates whether a call to the get_prolongation_matrix() function will generate an error or not.

Note, that this function returns true only if the prolongation matrices of the isotropic and all anisotropic refinement cases are implemented. If you are interested in the prolongation matrices for isotropic refinement only, use the isotropic_prolongation_is_implemented function instead.

This function is mostly here in order to allow us to write more efficient test programs which we run on all kinds of weird elements, and for which we simply need to exclude certain tests in case something is not implemented. It will in general probably not be a great help in applications, since there is not much one can do if one needs these features and they are not implemented. This function could be used to check whether a call to get_prolongation_matrix() will succeed; however, one then still needs to cope with the lack of information this just expresses.

◆ isotropic_prolongation_is_implemented()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::isotropic_prolongation_is_implemented ( ) const

Return whether this element implements its prolongation matrices for isotropic children. The return value also indicates whether a call to the get_prolongation_matrix function will generate an error or not.

This function is mostly here in order to allow us to write more efficient test programs which we run on all kinds of weird elements, and for which we simply need to exclude certain tests in case something is not implemented. It will in general probably not be a great help in applications, since there is not much one can do if one needs these features and they are not implemented. This function could be used to check whether a call to get_prolongation_matrix() will succeed; however, one then still needs to cope with the lack of information this just expresses.

◆ restriction_is_implemented()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::restriction_is_implemented ( ) const

Return whether this element implements its restriction matrices. The return value also indicates whether a call to the get_restriction_matrix() function will generate an error or not.

Note, that this function returns true only if the restriction matrices of the isotropic and all anisotropic refinement cases are implemented. If you are interested in the restriction matrices for isotropic refinement only, use the isotropic_restriction_is_implemented() function instead.

This function is mostly here in order to allow us to write more efficient test programs which we run on all kinds of weird elements, and for which we simply need to exclude certain tests in case something is not implemented. It will in general probably not be a great help in applications, since there is not much one can do if one needs these features and they are not implemented. This function could be used to check whether a call to get_restriction_matrix() will succeed; however, one then still needs to cope with the lack of information this just expresses.

◆ isotropic_restriction_is_implemented()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::isotropic_restriction_is_implemented ( ) const

Return whether this element implements its restriction matrices for isotropic children. The return value also indicates whether a call to the get_restriction_matrix() function will generate an error or not.

This function is mostly here in order to allow us to write more efficient test programs which we run on all kinds of weird elements, and for which we simply need to exclude certain tests in case something is not implemented. It will in general probably not be a great help in applications, since there is not much one can do if one needs these features and they are not implemented. This function could be used to check whether a call to get_restriction_matrix() will succeed; however, one then still needs to cope with the lack of information this just expresses.

◆ restriction_is_additive()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::restriction_is_additive ( const unsigned int  index) const

Access the restriction_is_additive_flags field. See the discussion about restriction matrices in the general class documentation for more information.

The index must be between zero and the number of shape functions of this element.

◆ constraints()

template<int dim, int spacedim = dim>
const FullMatrix< double > & FiniteElement< dim, spacedim >::constraints ( const ::internal::SubfaceCase< dim > &  subface_case = ::internal::SubfaceCase< dim >::case_isotropic) const

Return a read only reference to the matrix that describes the constraints at the interface between a refined and an unrefined cell.

Some finite elements do not (yet) implement hanging node constraints. If this is the case, then this function will generate an exception, since no useful return value can be generated. If you should have a way to live with this, then you might want to use the constraints_are_implemented() function to check up front whether this function will succeed or generate the exception.

◆ constraints_are_implemented()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::constraints_are_implemented ( const ::internal::SubfaceCase< dim > &  subface_case = ::internal::SubfaceCase< dim >::case_isotropic) const

Return whether this element implements its hanging node constraints. The return value also indicates whether a call to the constraints() function will generate an error or not.

This function is mostly here in order to allow us to write more efficient test programs which we run on all kinds of weird elements, and for which we simply need to exclude certain tests in case hanging node constraints are not implemented. It will in general probably not be a great help in applications, since there is not much one can do if one needs hanging node constraints and they are not implemented. This function could be used to check whether a call to constraints() will succeed; however, one then still needs to cope with the lack of information this just expresses.

◆ hp_constraints_are_implemented()

template<int dim, int spacedim = dim>
virtual bool FiniteElement< dim, spacedim >::hp_constraints_are_implemented ( ) const
virtual

Return whether this element implements its hanging node constraints in the new way, which has to be used to make elements "hp-compatible". That means, the element properly implements the get_face_interpolation_matrix and get_subface_interpolation_matrix methods. Therefore the return value also indicates whether a call to the get_face_interpolation_matrix() method and the get_subface_interpolation_matrix() method will generate an error or not.

Currently the main purpose of this function is to allow the make_hanging_node_constraints method to decide whether the new procedures, which are supposed to work in the hp-framework can be used, or if the old well verified but not hp-capable functions should be used. Once the transition to the new scheme for computing the interface constraints is complete, this function will be superfluous and will probably go away.

Derived classes should implement this function accordingly. The default assumption is that a finite element does not provide hp-capable face interpolation, and the default implementation therefore returns false.

Reimplemented in FE_Bernstein< dim, spacedim >, FE_DGP< dim, spacedim >, FE_DGPMonomial< dim >, FE_DGPNonparametric< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Enriched< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_FaceQ< 1, spacedim >, FE_FaceP< dim, spacedim >, FE_Nedelec< dim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FE_Q_Hierarchical< dim >, FE_RaviartThomasNodal< dim >, FE_SimplexPoly< dim, spacedim >, FE_SimplexPoly< dim, dim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, and FE_TraceQ< dim, spacedim >.

◆ get_interpolation_matrix()

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::get_interpolation_matrix ( const FiniteElement< dim, spacedim > &  source,
FullMatrix< double > &  matrix 
) const
virtual

Return the matrix interpolating from the given finite element to the present one. The size of the matrix is then dofs_per_cell times source.dofs_per_cell.

Derived elements will have to implement this function. They may only provide interpolation matrices for certain source finite elements, for example those from the same family. If they don't implement interpolation from a given element, then they must throw an exception of type ExcInterpolationNotImplemented.

Reimplemented in FE_Bernstein< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FE_Q_Bubbles< dim, spacedim >, FE_Q_DG0< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, FE_Nothing< dim, spacedim >, and FE_Nothing< dim, dim >.

◆ get_face_interpolation_matrix()

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::get_face_interpolation_matrix ( const FiniteElement< dim, spacedim > &  source,
FullMatrix< double > &  matrix,
const unsigned int  face_no = 0 
) const
virtual

Return the matrix interpolating from a face of one element to the face of the neighboring element. The size of the matrix is then source.dofs_per_face times this->dofs_per_face.

Derived elements will have to implement this function. They may only provide interpolation matrices for certain source finite elements, for example those from the same family. If they don't implement interpolation from a given element, then they must throw an exception of type ExcInterpolationNotImplemented.

Reimplemented in FE_Bernstein< dim, spacedim >, FE_DGP< dim, spacedim >, FE_DGPNonparametric< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Enriched< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_FaceP< dim, spacedim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, FE_TraceQ< dim, spacedim >, FE_SimplexPoly< dim, spacedim >, FE_SimplexPoly< dim, dim >, FE_Nothing< dim, spacedim >, and FE_Nothing< dim, dim >.

◆ get_subface_interpolation_matrix()

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::get_subface_interpolation_matrix ( const FiniteElement< dim, spacedim > &  source,
const unsigned int  subface,
FullMatrix< double > &  matrix,
const unsigned int  face_no = 0 
) const
virtual

Return the matrix interpolating from a face of one element to the subface of the neighboring element. The size of the matrix is then source.dofs_per_face times this->dofs_per_face.

Derived elements will have to implement this function. They may only provide interpolation matrices for certain source finite elements, for example those from the same family. If they don't implement interpolation from a given element, then they must throw an exception of type ExcInterpolationNotImplemented.

Reimplemented in FE_Bernstein< dim, spacedim >, FE_DGP< dim, spacedim >, FE_DGPNonparametric< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Enriched< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_FaceP< dim, spacedim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, FE_TraceQ< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_SimplexPoly< dim, spacedim >, and FE_SimplexPoly< dim, dim >.

◆ hp_vertex_dof_identities()

template<int dim, int spacedim = dim>
virtual std::vector< std::pair< unsigned int, unsigned int > > FiniteElement< dim, spacedim >::hp_vertex_dof_identities ( const FiniteElement< dim, spacedim > &  fe_other) const
virtual

If, on a vertex, several finite elements are active, the hp-code first assigns the degrees of freedom of each of these FEs different global indices. It then calls this function to find out which of them should get identical values, and consequently can receive the same global DoF index. This function therefore returns a list of identities between DoFs of the present finite element object with the DoFs of fe_other, which is a reference to a finite element object representing one of the other finite elements active on this particular vertex. The function computes which of the degrees of freedom of the two finite element objects are equivalent, both numbered between zero and the corresponding value of n_dofs_per_vertex() of the two finite elements. The first index of each pair denotes one of the vertex dofs of the present element, whereas the second is the corresponding index of the other finite element.

Reimplemented in FE_Bernstein< dim, spacedim >, FE_DGP< dim, spacedim >, FE_DGPNonparametric< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Enriched< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_PyramidP< dim, spacedim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FE_SimplexP< dim, spacedim >, FE_SimplexDGP< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, and FE_WedgeP< dim, spacedim >.

◆ hp_line_dof_identities()

template<int dim, int spacedim = dim>
virtual std::vector< std::pair< unsigned int, unsigned int > > FiniteElement< dim, spacedim >::hp_line_dof_identities ( const FiniteElement< dim, spacedim > &  fe_other) const
virtual

◆ hp_quad_dof_identities()

template<int dim, int spacedim = dim>
virtual std::vector< std::pair< unsigned int, unsigned int > > FiniteElement< dim, spacedim >::hp_quad_dof_identities ( const FiniteElement< dim, spacedim > &  fe_other,
const unsigned int  face_no = 0 
) const
virtual

◆ compare_for_domination()

template<int dim, int spacedim = dim>
virtual FiniteElementDomination::Domination FiniteElement< dim, spacedim >::compare_for_domination ( const FiniteElement< dim, spacedim > &  fe_other,
const unsigned int  codim = 0 
) const
virtual

Return whether this element dominates another one given as argument fe_other, whether it is the other way around, whether neither dominates, or if either could dominate. The codim parameter describes the codimension of the investigated subspace and specifies that it is subject to this comparison. For example, if codim==0 then this function compares which element dominates at the cell level. If codim==1, then the elements are compared at faces, i.e., the comparison happens between the function spaces of the two finite elements as restricted to a face. Larger values of codim work correspondingly.

For a definition of domination, see FiniteElementDomination::Domination and in particular the hp-paper.

Reimplemented in FE_PyramidP< dim, spacedim >, FE_SimplexP< dim, spacedim >, FE_SimplexDGP< dim, spacedim >, FE_WedgeP< dim, spacedim >, FE_Bernstein< dim, spacedim >, FE_DGP< dim, spacedim >, FE_DGPNonparametric< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_Enriched< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_FaceP< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_Q< dim, spacedim >, FE_Q< dim, dim >, FE_Q_Bubbles< dim, spacedim >, FE_Q_DG0< dim, spacedim >, FE_Q_iso_Q1< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, and FE_TraceQ< dim, spacedim >.

◆ operator==() [1/2]

template<int dim, int spacedim = dim>
virtual bool FiniteElement< dim, spacedim >::operator== ( const FiniteElement< dim, spacedim > &  fe) const
virtual

Comparison operator.

The implementation in the current class checks for equality of the following pieces of information between the current object and the one given as argument, in this order:

  • the dynamic type (i.e., the type of the most derived class) of the current object and of the given object,
  • the name returned by get_name(),
  • as all of the fields in FiniteElementData,
  • constraint matrices.

This covers most cases where elements can differ, but there are cases of derived elements that are different and for which the current function still returns true. For these cases, derived classes should overload this function.

Note
This operator specifically does not check the following member variables of the current class:
  • restriction matrices,
  • prolongation matrices of this object and the argument. This is because these member variables may be initialized only on demand by derived classes, rather than being available immediately. Consequently, comparing these members would not only be costly because these are generally big arrays, but also because their computation may be expensive. On the other hand, derived classes for which these arrays may differ for two objects even though the above list compares as equal, will probably want to implement their own operator==() anyway.

◆ operator!=()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::operator!= ( const FiniteElement< dim, spacedim > &  ) const

Non-equality comparison operator. Defined in terms of the equality comparison operator.

◆ system_to_component_index()

template<int dim, int spacedim = dim>
std::pair< unsigned int, unsigned int > FiniteElement< dim, spacedim >::system_to_component_index ( const unsigned int  index) const

Compute vector component and index of this shape function within the shape functions corresponding to this component from the index of a shape function within this finite element.

If the element is scalar, then the component is always zero, and the index within this component is equal to the overall index.

If the shape function referenced has more than one non-zero component, then it cannot be associated with one vector component, and an exception of type ExcShapeFunctionNotPrimitive will be raised.

Note that if the element is composed of other (base) elements, and a base element has more than one component but all its shape functions are primitive (i.e. are non-zero in only one component), then this mapping contains valid information. However, the index of a shape function of this element within one component (i.e. the second number of the respective entry of this array) does not indicate the index of the respective shape function within the base element (since that has more than one vector-component). For this information, refer to the system_to_base_table field and the system_to_base_index() function.

See the class description above for an example of how this function is typically used.

The use of this function is explained extensively in the step-8 and step-20 tutorial programs as well as in the Handling vector valued problems module.

◆ component_to_system_index()

template<int dim, int spacedim = dim>
unsigned int FiniteElement< dim, spacedim >::component_to_system_index ( const unsigned int  component,
const unsigned int  index 
) const

Compute the shape function for the given vector component and index.

If the element is scalar, then the component must be zero, and the index within this component is equal to the overall index.

This is the opposite operation from the system_to_component_index() function.

◆ face_system_to_component_index()

template<int dim, int spacedim = dim>
std::pair< unsigned int, unsigned int > FiniteElement< dim, spacedim >::face_system_to_component_index ( const unsigned int  index,
const unsigned int  face_no = 0 
) const

Same as system_to_component_index(), but do it for shape functions and their indices on a face. The range of allowed indices is therefore 0..dofs_per_face.

You will rarely need this function in application programs, since almost all application codes only need to deal with cell indices, not face indices. The function is mainly there for use inside the library.

◆ adjust_quad_dof_index_for_face_orientation()

template<int dim, int spacedim = dim>
unsigned int FiniteElement< dim, spacedim >::adjust_quad_dof_index_for_face_orientation ( const unsigned int  index,
const unsigned int  face_no,
const bool  face_orientation,
const bool  face_flip,
const bool  face_rotation 
) const

For faces with non-standard face_orientation in 3d, the dofs on faces (quads) have to be permuted in order to be combined with the correct shape functions. Given a local dof index on a quad, return the local index, if the face has non-standard face_orientation, face_flip or face_rotation. In 2d and 1d there is no need for permutation and consequently an exception is thrown.

◆ face_to_cell_index()

template<int dim, int spacedim = dim>
virtual unsigned int FiniteElement< dim, spacedim >::face_to_cell_index ( const unsigned int  face_dof_index,
const unsigned int  face,
const bool  face_orientation = true,
const bool  face_flip = false,
const bool  face_rotation = false 
) const
virtual

Given an index in the natural ordering of indices on a face, return the index of the same degree of freedom on the cell.

To explain the concept, consider the case where we would like to know whether a degree of freedom on a face, for example as part of an FESystem element, is primitive. Unfortunately, the is_primitive() function in the FiniteElement class takes a cell index, so we would need to find the cell index of the shape function that corresponds to the present face index. This function does that.

Code implementing this would then look like this:

for (i=0; i<dofs_per_face; ++i)
if (fe.is_primitive(fe.face_to_cell_index(i, some_face_no)))
... do whatever
const unsigned int dofs_per_face
Definition fe_data.h:423

The function takes additional arguments that account for the fact that actual faces can be in their standard ordering with respect to the cell under consideration, or can be flipped, oriented, etc.

Parameters
face_dof_indexThe index of the degree of freedom on a face. This index must be between zero and dofs_per_face.
faceThe number of the face this degree of freedom lives on. This number must be between zero and GeometryInfo::faces_per_cell.
face_orientationOne part of the description of the orientation of the face. See GlossFaceOrientation.
face_flipOne part of the description of the orientation of the face. See GlossFaceOrientation.
face_rotationOne part of the description of the orientation of the face. See GlossFaceOrientation.
Returns
The index of this degree of freedom within the set of degrees of freedom on the entire cell. The returned value will be between zero and dofs_per_cell.
Note
This function exists in this class because that is where it was first implemented. However, it can't really work in the most general case without knowing what element we have. The reason is that when a face is flipped or rotated, we also need to know whether we need to swap the degrees of freedom on this face, or whether they are immune from this. For this, consider the situation of a \(Q_3\) element in 2d. If face_flip is true, then we need to consider the two degrees of freedom on the edge in reverse order. On the other hand, if the element were a \(Q_1^2\), then because the two degrees of freedom on this edge belong to different vector components, they should not be considered in reverse order. What all of this shows is that the function can't work if there are more than one degree of freedom per line or quad, and that in these cases the function will throw an exception pointing out that this functionality will need to be provided by a derived class that knows what degrees of freedom actually represent.

Reimplemented in FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ adjust_line_dof_index_for_line_orientation()

template<int dim, int spacedim = dim>
unsigned int FiniteElement< dim, spacedim >::adjust_line_dof_index_for_line_orientation ( const unsigned int  index,
const bool  line_orientation 
) const

For lines with non-standard line_orientation in 3d, the dofs on lines have to be permuted in order to be combined with the correct shape functions. Given a local dof index on a line, return the local index, if the line has non-standard line_orientation. In 2d and 1d there is no need for permutation, so the given index is simply returned.

◆ get_nonzero_components()

template<int dim, int spacedim = dim>
const ComponentMask & FiniteElement< dim, spacedim >::get_nonzero_components ( const unsigned int  i) const

Return in which of the vector components of this finite element the ith shape function is non-zero. The length of the returned array is equal to the number of vector components of this element.

For most finite element spaces, the result of this function will be a vector with exactly one element being true, since for most spaces the individual vector components are independent. In that case, the component with the single zero is also the first element of what system_to_component_index() returns.

Only for those spaces that couple the components, for example to make a shape function divergence free, will there be more than one true entry. Elements for which this is true are called non-primitive (see GlossPrimitive).

◆ n_nonzero_components()

template<int dim, int spacedim = dim>
unsigned int FiniteElement< dim, spacedim >::n_nonzero_components ( const unsigned int  i) const

Return in how many vector components the ith shape function is non-zero. This value equals the number of entries equal to true in the result of the get_nonzero_components() function.

For most finite element spaces, the result will be equal to one. It is not equal to one only for those ansatz spaces for which vector-valued shape functions couple the individual components, for example in order to make them divergence-free.

◆ is_primitive() [1/2]

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::is_primitive ( ) const

Return whether the entire finite element is primitive, in the sense that all its shape functions are primitive. If the finite element is scalar, then this is always the case.

Since this is an extremely common operation, the result is cached and returned by this function.

◆ is_primitive() [2/2]

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::is_primitive ( const unsigned int  i) const

Return whether the ith shape function is primitive in the sense that the shape function is non-zero in only one vector component. Non- primitive shape functions would then, for example, be those of divergence free ansatz spaces, in which the individual vector components are coupled.

The result of the function is true if and only if the result of n_nonzero_components(i) is equal to one.

◆ n_base_elements()

template<int dim, int spacedim = dim>
unsigned int FiniteElement< dim, spacedim >::n_base_elements ( ) const

Number of base elements in a mixed discretization.

Note that even for vector valued finite elements, the number of components needs not coincide with the number of base elements, since they may be reused. For example, if you create a FESystem with three identical finite element classes by using the constructor that takes one finite element and a multiplicity, then the number of base elements is still one, although the number of components of the finite element is equal to the multiplicity.

◆ base_element()

template<int dim, int spacedim = dim>
virtual const FiniteElement< dim, spacedim > & FiniteElement< dim, spacedim >::base_element ( const unsigned int  index) const
virtual

Access to base element objects. If the element is atomic, then base_element(0) is this.

Reimplemented in FE_Enriched< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ element_multiplicity()

template<int dim, int spacedim = dim>
unsigned int FiniteElement< dim, spacedim >::element_multiplicity ( const unsigned int  index) const

This index denotes how often the base element index is used in a composed element. If the element is atomic, then the result is always equal to one. See the documentation for the n_base_elements() function for more details.

◆ get_sub_fe() [1/2]

template<int dim, int spacedim = dim>
const FiniteElement< dim, spacedim > & FiniteElement< dim, spacedim >::get_sub_fe ( const ComponentMask mask) const

Return a reference to a contained finite element that matches the components selected by the given ComponentMask mask.

For an arbitrarily nested FESystem, this function returns the inner-most FiniteElement that matches the given mask. The method fails if the mask does not exactly match one of the contained finite elements. It is most useful if the current object is an FESystem, as the return value can only be this in all other cases.

Note that the returned object can be an FESystem if the mask matches it but not any of the contained objects.

Let us illustrate the function with the an FESystem fe with 7 components:

FESystem<2> fe_velocity(FE_Q<2>(2), 2);
FE_Q<2> fe_pressure(1);
FE_DGP<2> fe_dg(0);
FE_BDM<2> fe_nonprim(1);
FESystem<2> fe(fe_velocity, 1, fe_pressure, 1, fe_dg, 2, fe_nonprim, 1);

The following table lists all possible component masks you can use:

ComponentMask Result Description
[true,true,true,true,true,true,true] FESystem<2>[FESystem<2>[FE_Q<2>(2)^2]-FE_Q<2>(1)-FE_DGP<2>(0)^2-FE_BDM<2>(1)] fe itself, the whole FESystem
[true,true,false,false,false,false,false] FESystem<2>[FE_Q<2>(2)^2] just the fe_velocity
[true,false,false,false,false,false,false] FE_Q<2>(2) The first component in fe_velocity
[false,true,false,false,false,false,false] FE_Q<2>(2) The second component in fe_velocity
[false,false,true,false,false,false,false] FE_Q<2>(1) fe_pressure
[false,false,false,true,false,false,false] FE_DGP<2>(0) first copy of fe_dg
[false,false,false,false,true,false,false] FE_DGP<2>(0) second copy of fe_dg
[false,false,false,false,false,true,true] FE_BDM<2>(1) both components of fe_nonprim

◆ get_sub_fe() [2/2]

template<int dim, int spacedim = dim>
virtual const FiniteElement< dim, spacedim > & FiniteElement< dim, spacedim >::get_sub_fe ( const unsigned int  first_component,
const unsigned int  n_selected_components 
) const
virtual

Return a reference to a contained finite element that matches the components n_selected_components components starting at component with index first_component.

See the other get_sub_fe() function above for more details.

Reimplemented in FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ system_to_base_index()

template<int dim, int spacedim = dim>
std::pair< std::pair< unsigned int, unsigned int >, unsigned int > FiniteElement< dim, spacedim >::system_to_base_index ( const unsigned int  index) const

Return for shape function index the base element it belongs to, the number of the copy of this base element (which is between zero and the multiplicity of this element), and the index of this shape function within this base element.

If the element is not composed of others, then base and instance are always zero, and the index is equal to the number of the shape function. If the element is composed of single instances of other elements (i.e. all with multiplicity one) all of which are scalar, then base values and dof indices within this element are equal to the system_to_component_table. It differs only in case the element is composed of other elements and at least one of them is vector-valued itself.

See the class documentation above for an example of how this function is typically used.

This function returns valid values also in the case of vector-valued (i.e. non-primitive) shape functions, in contrast to the system_to_component_index() function.

◆ face_system_to_base_index()

template<int dim, int spacedim = dim>
std::pair< std::pair< unsigned int, unsigned int >, unsigned int > FiniteElement< dim, spacedim >::face_system_to_base_index ( const unsigned int  index,
const unsigned int  face_no = 0 
) const

Same as system_to_base_index(), but for degrees of freedom located on a face. The range of allowed indices is therefore 0..dofs_per_face.

You will rarely need this function in application programs, since almost all application codes only need to deal with cell indices, not face indices. The function is mainly there for use inside the library.

◆ first_block_of_base()

template<int dim, int spacedim = dim>
types::global_dof_index FiniteElement< dim, spacedim >::first_block_of_base ( const unsigned int  b) const

Given a base element number, return the first block of a BlockVector it would generate.

◆ component_to_base_index()

template<int dim, int spacedim = dim>
std::pair< unsigned int, unsigned int > FiniteElement< dim, spacedim >::component_to_base_index ( const unsigned int  component) const

For each vector component, return which base element implements this component and which vector component in this base element this is. This information is only of interest for vector-valued finite elements which are composed of several sub-elements. In that case, one may want to obtain information about the element implementing a certain vector component, which can be done using this function and the FESystem::base_element() function.

If this is a scalar finite element, then the return value is always equal to a pair of zeros.

◆ block_to_base_index()

template<int dim, int spacedim = dim>
std::pair< unsigned int, unsigned int > FiniteElement< dim, spacedim >::block_to_base_index ( const unsigned int  block) const

Return the base element for this block and the number of the copy of the base element.

◆ system_to_block_index()

template<int dim, int spacedim = dim>
std::pair< unsigned int, types::global_dof_index > FiniteElement< dim, spacedim >::system_to_block_index ( const unsigned int  component) const

The vector block and the index inside the block for this shape function.

◆ component_to_block_index()

template<int dim, int spacedim = dim>
unsigned int FiniteElement< dim, spacedim >::component_to_block_index ( const unsigned int  component) const

The vector block for this component.

◆ component_mask() [1/4]

template<int dim, int spacedim = dim>
ComponentMask FiniteElement< dim, spacedim >::component_mask ( const FEValuesExtractors::Scalar scalar) const

Return a component mask with as many elements as this object has vector components and of which exactly the one component is true that corresponds to the given argument. See the glossary for more information.

Parameters
scalarAn object that represents a single scalar vector component of this finite element.
Returns
A component mask that is false in all components except for the one that corresponds to the argument.

◆ component_mask() [2/4]

template<int dim, int spacedim = dim>
ComponentMask FiniteElement< dim, spacedim >::component_mask ( const FEValuesExtractors::Vector vector) const

Return a component mask with as many elements as this object has vector components and of which exactly the dim components are true that correspond to the given argument. See the glossary for more information.

Parameters
vectorAn object that represents dim vector components of this finite element.
Returns
A component mask that is false in all components except for the ones that corresponds to the argument.

◆ component_mask() [3/4]

template<int dim, int spacedim = dim>
ComponentMask FiniteElement< dim, spacedim >::component_mask ( const FEValuesExtractors::SymmetricTensor< 2 > &  sym_tensor) const

Return a component mask with as many elements as this object has vector components and of which exactly the dim*(dim+1)/2 components are true that correspond to the given argument. See the glossary for more information.

Parameters
sym_tensorAn object that represents dim*(dim+1)/2 components of this finite element that are jointly to be interpreted as forming a symmetric tensor.
Returns
A component mask that is false in all components except for the ones that corresponds to the argument.

◆ component_mask() [4/4]

template<int dim, int spacedim = dim>
ComponentMask FiniteElement< dim, spacedim >::component_mask ( const BlockMask block_mask) const

Given a block mask (see this glossary entry), produce a component mask (see this glossary entry) that represents the components that correspond to the blocks selected in the input argument. This is essentially a conversion operator from BlockMask to ComponentMask.

Parameters
block_maskThe mask that selects individual blocks of the finite element
Returns
A mask that selects those components corresponding to the selected blocks of the input argument.

◆ block_mask() [1/4]

template<int dim, int spacedim = dim>
BlockMask FiniteElement< dim, spacedim >::block_mask ( const FEValuesExtractors::Scalar scalar) const

Return a block mask with as many elements as this object has blocks and of which exactly the one component is true that corresponds to the given argument. See the glossary for more information.

Note
This function will only succeed if the scalar referenced by the argument encompasses a complete block. In other words, if, for example, you pass an extractor for the single \(x\) velocity and this object represents an FE_RaviartThomas object, then the single scalar object you selected is part of a larger block and consequently there is no block mask that would represent it. The function will then produce an exception.
Parameters
scalarAn object that represents a single scalar vector component of this finite element.
Returns
A component mask that is false in all components except for the one that corresponds to the argument.

◆ block_mask() [2/4]

template<int dim, int spacedim = dim>
BlockMask FiniteElement< dim, spacedim >::block_mask ( const FEValuesExtractors::Vector vector) const

Return a component mask with as many elements as this object has vector components and of which exactly the dim components are true that correspond to the given argument. See the glossary for more information.

Note
The same caveat applies as to the version of the function above: The extractor object passed as argument must be so that it corresponds to full blocks and does not split blocks of this element.
Parameters
vectorAn object that represents dim vector components of this finite element.
Returns
A component mask that is false in all components except for the ones that corresponds to the argument.

◆ block_mask() [3/4]

template<int dim, int spacedim = dim>
BlockMask FiniteElement< dim, spacedim >::block_mask ( const FEValuesExtractors::SymmetricTensor< 2 > &  sym_tensor) const

Return a component mask with as many elements as this object has vector components and of which exactly the dim*(dim+1)/2 components are true that correspond to the given argument. See the glossary for more information.

Note
The same caveat applies as to the version of the function above: The extractor object passed as argument must be so that it corresponds to full blocks and does not split blocks of this element.
Parameters
sym_tensorAn object that represents dim*(dim+1)/2 components of this finite element that are jointly to be interpreted as forming a symmetric tensor.
Returns
A component mask that is false in all components except for the ones that corresponds to the argument.

◆ block_mask() [4/4]

template<int dim, int spacedim = dim>
BlockMask FiniteElement< dim, spacedim >::block_mask ( const ComponentMask component_mask) const

Given a component mask (see this glossary entry), produce a block mask (see this glossary entry) that represents the blocks that correspond to the components selected in the input argument. This is essentially a conversion operator from ComponentMask to BlockMask.

Note
This function will only succeed if the components referenced by the argument encompasses complete blocks. In other words, if, for example, you pass an component mask for the single \(x\) velocity and this object represents an FE_RaviartThomas object, then the single component you selected is part of a larger block and consequently there is no block mask that would represent it. The function will then produce an exception.
Parameters
component_maskThe mask that selects individual components of the finite element
Returns
A mask that selects those blocks corresponding to the selected blocks of the input argument.

◆ get_constant_modes()

template<int dim, int spacedim = dim>
virtual std::pair< Table< 2, bool >, std::vector< unsigned int > > FiniteElement< dim, spacedim >::get_constant_modes ( ) const
virtual

Return a list of constant modes of the element. The number of rows in the resulting table depends on the elements in use. For standard elements, the table has as many rows as there are components in the element and dofs_per_cell columns. To each component of the finite element, the row in the returned table contains a basis representation of the constant function 1 on the element. However, there are some scalar elements where there is more than one constant mode, e.g. the element FE_Q_DG0.

In order to match the constant modes to the actual components in the element, the returned data structure also returns a vector with as many components as there are constant modes on the element that contains the component number.

Reimplemented in FE_DGP< dim, spacedim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_DGQLegendre< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_FaceQ< 1, spacedim >, FE_FaceP< dim, spacedim >, FE_Nedelec< dim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_Q_Base< dim, spacedim >, FE_Q_Base< dim, dim >, FE_Q_Base< dim, spacedim >, FE_Q_DG0< dim, spacedim >, FE_Q_Hierarchical< dim >, FE_RaviartThomas< dim >, FE_SimplexPoly< dim, spacedim >, FE_SimplexPoly< dim, dim >, FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, and FE_TraceQ< dim, spacedim >.

◆ get_unit_support_points()

template<int dim, int spacedim = dim>
const std::vector< Point< dim > > & FiniteElement< dim, spacedim >::get_unit_support_points ( ) const

Return the support points of the trial functions on the unit cell, if the derived finite element defines them. Finite elements that allow some kind of interpolation operation usually have support points. On the other hand, elements that define their degrees of freedom by, for example, moments on faces, or as derivatives, don't have support points. In that case, the returned field is empty.

If the finite element defines support points, then their number equals the number of degrees of freedom of the element. The order of points in the array matches that returned by the cell->get_dof_indices function.

See the class documentation for details on support points.

Note
Finite elements' implementation of this function returns these points in the same order as shape functions. The order of shape functions is typically documented in the class documentation of the various finite element classes. In particular, shape functions (and consequently the mapped quadrature points discussed in the class documentation of this class) will then traverse first those shape functions located on vertices, then on lines, then on quads, etc.
If this element implements support points, then it will return one such point per shape function. Since multiple shape functions may be defined at the same location, the support points returned here may be duplicated. An example would be an element of the kind FESystem(FE_Q(1),3) for which each support point would appear three times in the returned array.

◆ has_support_points()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::has_support_points ( ) const

Return whether a finite element has defined support points. If the result is true, then a call to the get_unit_support_points() yields a non-empty array.

The result may be false if an element is not defined by interpolating shape functions, for example by P-elements on quadrilaterals. It will usually only be true if the element constructs its shape functions by the requirement that they be one at a certain point and zero at all the points associated with the other shape functions.

In composed elements (i.e. for the FESystem class), the result will be true if all the base elements have defined support points. FE_Nothing is a special case in FESystems, because it has 0 support points and has_support_points() is false, but an FESystem containing an FE_Nothing among other elements will return true.

◆ unit_support_point()

template<int dim, int spacedim = dim>
virtual Point< dim > FiniteElement< dim, spacedim >::unit_support_point ( const unsigned int  index) const
virtual

Return the position of the support point of the indexth shape function. If it does not exist, raise an exception.

The default implementation simply returns the respective element from the array you get from get_unit_support_points(), but derived elements may overload this function. In particular, note that the FESystem class overloads it so that it can return the support points of individual base elements, if not all the base elements define support points. In this way, you can still ask for certain support points, even if get_unit_support_points() only returns an empty array.

Reimplemented in FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ get_unit_face_support_points()

template<int dim, int spacedim = dim>
const std::vector< Point< dim - 1 > > & FiniteElement< dim, spacedim >::get_unit_face_support_points ( const unsigned int  face_no = 0) const

Return the support points of the trial functions on the unit face, if the derived finite element defines some. Finite elements that allow some kind of interpolation operation usually have support points. On the other hand, elements that define their degrees of freedom by, for example, moments on faces, or as derivatives, don't have support points. In that case, the returned field is empty

Note that elements that have support points need not necessarily have some on the faces, even if the interpolation points are located physically on a face. For example, the discontinuous elements have interpolation points on the vertices, and for higher degree elements also on the faces, but they are not defined to be on faces since in that case degrees of freedom from both sides of a face (or from all adjacent elements to a vertex) would be identified with each other, which is not what we would like to have). Logically, these degrees of freedom are therefore defined to belong to the cell, rather than the face or vertex. In that case, the returned element would therefore have length zero.

If the finite element defines support points, then their number equals the number of degrees of freedom on the face (dofs_per_face). The order of points in the array matches that returned by the cell->face(face)->get_dof_indices function.

See the class documentation for details on support points.

◆ has_face_support_points()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::has_face_support_points ( const unsigned int  face_no = 0) const

Return whether a finite element has defined support points on faces. If the result is true, then a call to the get_unit_face_support_points() yields a non-empty vector.

For more information, see the documentation for the has_support_points() function.

◆ unit_face_support_point()

template<int dim, int spacedim = dim>
virtual Point< dim - 1 > FiniteElement< dim, spacedim >::unit_face_support_point ( const unsigned int  index,
const unsigned int  face_no = 0 
) const
virtual

The function corresponding to the unit_support_point() function, but for faces. See there for more information.

Reimplemented in FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ get_generalized_support_points()

template<int dim, int spacedim = dim>
const std::vector< Point< dim > > & FiniteElement< dim, spacedim >::get_generalized_support_points ( ) const

Return a vector of generalized support points.

Note
The vector returned by this function is always a minimal set of unique support points. This is in contrast to the behavior of get_unit_support_points() that returns a repeated list of unit support points for an FESystem of numerous (Lagrangian) base elements. As a consequence, it is possible to have fewer generalized support points than degrees of freedom in the element. An example is the element FESystem<dim>(FE_Q<dim>(1), 2), which has two copies of the \(Q_1\) element. In 2d, each copy has 4 degrees of freedom, and each copy has its support points in the four vertices of the cell. While the get_support_points() function would return a vector of size 8 in which each of the vertices is listed twice, this function strips out the duplicates and returns a vector of length 4 in which each vertex is listed only once. This is possible because the purpose of this function is to return a list of points so that it is possible to interpolate an arbitrary function onto the finite element space, and this is possible by knowing the two components of the function in question at the four vertices of the cell – it is not necessary to ask for this information twice at each vertex.

See the glossary entry on generalized support points for more information.

◆ has_generalized_support_points()

template<int dim, int spacedim = dim>
bool FiniteElement< dim, spacedim >::has_generalized_support_points ( ) const

Return whether a finite element has defined generalized support points. If the result is true, then a call to the get_generalized_support_points() yields a non-empty vector.

See the glossary entry on generalized support points for more information.

◆ get_associated_geometry_primitive()

template<int dim, int spacedim = dim>
GeometryPrimitive FiniteElement< dim, spacedim >::get_associated_geometry_primitive ( const unsigned int  cell_dof_index) const

For a given degree of freedom, return whether it is logically associated with a vertex, line, quad or hex.

For instance, for continuous finite elements this coincides with the lowest dimensional object the support point of the degree of freedom lies on. To give an example, for \(Q_1\) elements in 3d, every degree of freedom is defined by a shape function that we get by interpolating using support points that lie on the vertices of the cell. The support of these points of course extends to all edges connected to this vertex, as well as the adjacent faces and the cell interior, but we say that logically the degree of freedom is associated with the vertex as this is the lowest- dimensional object it is associated with. Likewise, for \(Q_2\) elements in 3d, the degrees of freedom with support points at edge midpoints would yield a value of GeometryPrimitive::line from this function, whereas those on the centers of faces in 3d would return GeometryPrimitive::quad.

To make this more formal, the kind of object returned by this function represents the object so that the support of the shape function corresponding to the degree of freedom, (i.e., that part of the domain where the function "lives") is the union of all of the cells sharing this object. To return to the example above, for \(Q_2\) in 3d, the shape function with support point at an edge midpoint has support on all cells that share the edge and not only the cells that share the adjacent faces, and consequently the function will return GeometryPrimitive::line.

On the other hand, for discontinuous elements of type \(DGQ_2\), a degree of freedom associated with an interpolation polynomial that has its support point physically located at a line bounding a cell, but is nonzero only on one cell. Consequently, it is logically associated with the interior of that cell (i.e., with a GeometryPrimitive::quad in 2d and a GeometryPrimitive::hex in 3d).

Parameters
[in]cell_dof_indexThe index of a shape function or degree of freedom. This index must be in the range [0,dofs_per_cell).
Note
The integer value of the object returned by this function equals the dimensionality of the object it describes, and can consequently be used in generic programming paradigms. For example, if a degree of freedom is associated with a vertex, then this function returns GeometryPrimitive::vertex, which has a numeric value of zero (the dimensionality of a vertex).

◆ convert_generalized_support_point_values_to_dof_values()

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::convert_generalized_support_point_values_to_dof_values ( const std::vector< Vector< double > > &  support_point_values,
std::vector< double > &  nodal_values 
) const
virtual

Given the values of a function \(f(\mathbf x)\) at the (generalized) support points of the reference cell, this function then computes what the nodal values of the element are, i.e., \(\Psi_i[f]\), where \(\Psi_i\) are the node functionals of the element (see also Node values or node functionals). The values \(\Psi_i[f]\) are then the expansion coefficients for the shape functions of the finite element function that interpolates the given function \(f(x)\), i.e., \( f_h(\mathbf x) = \sum_i \Psi_i[f] \varphi_i(\mathbf x) \) is the finite element interpolant of \(f\) with the current element. The operation described here is used, for example, in the FETools::compute_node_matrix() function.

In more detail, let us assume that the generalized support points (see this glossary entry ) of the current element are \(\hat{\mathbf x}_i\) and that the node functionals associated with the current element are \(\Psi_i[\cdot]\). Then, the fact that the element is based on generalized support points, implies that if we apply \(\Psi_i\) to a (possibly vector-valued) finite element function \(\varphi\), the result must have the form \(\Psi_i[\varphi] = f_i(\varphi(\hat{\mathbf x}_i))\) – in other words, the value of the node functional \(\Psi_i\) applied to \(\varphi\) only depends on the values of \(\varphi\) at \(\hat{\mathbf x}_i\) and not on values anywhere else, or integrals of \(\varphi\), or any other kind of information.

The exact form of \(f_i\) depends on the element. For example, for scalar Lagrange elements, we have that in fact \(\Psi_i[\varphi] = \varphi(\hat{\mathbf x}_i)\). If you combine multiple scalar Lagrange elements via an FESystem object, then \(\Psi_i[\varphi] = \varphi(\hat{\mathbf x}_i)_{c(i)}\) where \(c(i)\) is the result of the FiniteElement::system_to_component_index() function's return value's first component. In these two cases, \(f_i\) is therefore simply the identity (in the scalar case) or a function that selects a particular vector component of its argument. On the other hand, for Raviart-Thomas elements, one would have that \(f_i(\mathbf y) = \mathbf y \cdot \mathbf n_i\) where \(\mathbf n_i\) is the normal vector of the face at which the shape function is defined.

Given all of this, what this function does is the following: If you input a list of values of a function \(\varphi\) at all generalized support points (where each value is in fact a vector of values with as many components as the element has), then this function returns a vector of values obtained by applying the node functionals to these values. In other words, if you pass in \(\{\varphi(\hat{\mathbf x}_i)\}_{i=0}^{N-1}\) then you will get out a vector \(\{\Psi[\varphi]\}_{i=0}^{N-1}\) where \(N\) equals dofs_per_cell.

Parameters
[in]support_point_valuesAn array of size dofs_per_cell (which equals the number of points the get_generalized_support_points() function will return) where each element is a vector with as many entries as the element has vector components. This array should contain the values of a function at the generalized support points of the current element.
[out]nodal_valuesAn array of size dofs_per_cell that contains the node functionals of the element applied to the given function.
Note
It is safe to call this function for (transformed) values on the real cell only for elements with trivial MappingKind. For all other elements (for example for H(curl), or H(div) conforming elements) vector values have to be transformed to the reference cell first.
Given what the function is supposed to do, the function clearly can only work for elements that actually implement (generalized) support points. Elements that do not have generalized support points – e.g., elements whose nodal functionals evaluate integrals or moments of functions (such as FE_Q_Hierarchical) – can in general not make sense of the operation that is required for this function. They consequently may not implement it.

Reimplemented in FESystem< dim, spacedim >, FESystem< dim, dim >, FESystem< dim, spacedim >, FE_ABF< dim >, FE_BDM< dim >, FE_BernardiRaugel< dim >, FE_DGQ< dim, spacedim >, FE_DGQ< dim, dim >, FE_DGQArbitraryNodes< dim, spacedim >, FE_FaceQ< dim, spacedim >, FE_Nedelec< dim >, FE_PyramidPoly< dim, spacedim >, FE_PyramidPoly< dim, dim >, FE_Q< dim, spacedim >, FE_Q< dim, dim >, FE_Q_Bubbles< dim, spacedim >, FE_Q_DG0< dim, spacedim >, FE_Q_iso_Q1< dim, spacedim >, FE_RannacherTurek< dim >, FE_RaviartThomas< dim >, FE_RaviartThomasNodal< dim >, FE_RT_Bubbles< dim >, FE_SimplexPoly< dim, spacedim >, FE_SimplexPoly< dim, dim >, FE_TraceQ< dim, spacedim >, FE_WedgePoly< dim, spacedim >, and FE_WedgePoly< dim, dim >.

◆ memory_consumption()

template<int dim, int spacedim = dim>
virtual std::size_t FiniteElement< dim, spacedim >::memory_consumption ( ) const
virtual

◆ reinit_restriction_and_prolongation_matrices()

template<int dim, int spacedim = dim>
void FiniteElement< dim, spacedim >::reinit_restriction_and_prolongation_matrices ( const bool  isotropic_restriction_only = false,
const bool  isotropic_prolongation_only = false 
)
protected

Reinit the vectors of restriction and prolongation matrices to the right sizes: For every refinement case, except for RefinementCase::no_refinement, and for every child of that refinement case the space of one restriction and prolongation matrix is allocated, see the documentation of the restriction and prolongation vectors for more detail on the actual vector sizes.

Parameters
isotropic_restriction_onlyonly the restriction matrices required for isotropic refinement are reinited to the right size.
isotropic_prolongation_onlyonly the prolongation matrices required for isotropic refinement are reinited to the right size.

◆ interface_constraints_size()

template<int dim, int spacedim = dim>
TableIndices< 2 > FiniteElement< dim, spacedim >::interface_constraints_size ( ) const
protected

Return the size of interface constraint matrices. Since this is needed in every derived finite element class when initializing their size, it is placed into this function, to avoid having to recompute the dimension- dependent size of these matrices each time.

Note that some elements do not implement the interface constraints for certain polynomial degrees. In this case, this function still returns the size these matrices should have when implemented, but the actual matrices are empty.

◆ compute_n_nonzero_components()

template<int dim, int spacedim = dim>
static std::vector< unsigned int > FiniteElement< dim, spacedim >::compute_n_nonzero_components ( const std::vector< ComponentMask > &  nonzero_components)
staticprotected

Given the pattern of nonzero components for each shape function, compute for each entry how many components are non-zero for each shape function. This function is used in the constructor of this class.

◆ requires_update_flags()

template<int dim, int spacedim = dim>
virtual UpdateFlags FiniteElement< dim, spacedim >::requires_update_flags ( const UpdateFlags  update_flags) const
protectedpure virtual

Given a set of update flags, compute which other quantities also need to be computed in order to satisfy the request by the given flags. Then return the combination of the original set of flags and those just computed.

As an example, if update_flags contains update_gradients a finite element class will typically require the computation of the inverse of the Jacobian matrix in order to rotate the gradient of shape functions on the reference cell to the real cell. It would then return not just update_gradients, but also update_covariant_transformation, the flag that makes the mapping class produce the inverse of the Jacobian matrix.

An extensive discussion of the interaction between this function and FEValues can be found in the How Mapping, FiniteElement, and FEValues work together documentation module.

See also
The interplay of UpdateFlags, Mapping, and FiniteElement in FEValues

Implemented in FE_P1NC, FE_DGPNonparametric< dim, spacedim >, FE_Enriched< dim, spacedim >, FE_FaceQ< 1, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyFace< PolynomialType, dim, spacedim >, FE_PolyFace< PolynomialSpace< dim - 1 >, dim, dim >, FE_PolyFace< TensorProductPolynomials< dim - 1 >, dim, dim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ get_data()

template<int dim, int spacedim = dim>
virtual std::unique_ptr< InternalDataBase > FiniteElement< dim, spacedim >::get_data ( const UpdateFlags  update_flags,
const Mapping< dim, spacedim > &  mapping,
const Quadrature< dim > &  quadrature,
::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedpure virtual

Create an internal data object and return a pointer to it of which the caller of this function then assumes ownership. This object will then be passed to the FiniteElement::fill_fe_values() every time the finite element shape functions and their derivatives are evaluated on a concrete cell. The object created here is therefore used by derived classes as a place for scratch objects that are used in evaluating shape functions, as well as to store information that can be pre-computed once and re-used on every cell (e.g., for evaluating the values and gradients of shape functions on the reference cell, for later re-use when transforming these values to a concrete cell).

This function is the first one called in the process of initializing a FEValues object for a given mapping and finite element object. The returned object will later be passed to FiniteElement::fill_fe_values() for a concrete cell, which will itself place its output into an object of type internal::FEValuesImplementation::FiniteElementRelatedData. Since there may be data that can already be computed in its final form on the reference cell, this function also receives a reference to the internal::FEValuesImplementation::FiniteElementRelatedData object as its last argument. This output argument is guaranteed to always be the same one when used with the InternalDataBase object returned by this function. In other words, the subdivision of scratch data and final data in the returned object and the output_data object is as follows: If data can be pre- computed on the reference cell in the exact form in which it will later be needed on a concrete cell, then this function should already emplace it in the output_data object. An example are the values of shape functions at quadrature points for the usual Lagrange elements which on a concrete cell are identical to the ones on the reference cell. On the other hand, if some data can be pre-computed to make computations on a concrete cell cheaper, then it should be put into the returned object for later re-use in a derive class's implementation of FiniteElement::fill_fe_values(). An example are the gradients of shape functions on the reference cell for Lagrange elements: to compute the gradients of the shape functions on a concrete cell, one has to multiply the gradients on the reference cell by the inverse of the Jacobian of the mapping; consequently, we cannot already compute the gradients on a concrete cell at the time the current function is called, but we can at least pre-compute the gradients on the reference cell, and store it in the object returned.

An extensive discussion of the interaction between this function and FEValues can be found in the How Mapping, FiniteElement, and FEValues work together documentation module. See also the documentation of the InternalDataBase class.

Parameters
[in]update_flagsA set of UpdateFlags values that describe what kind of information the FEValues object requests the finite element to compute. This set of flags may also include information that the finite element can not compute, e.g., flags that pertain to data produced by the mapping. An implementation of this function needs to set up all data fields in the returned object that are necessary to produce the finite- element related data specified by these flags, and may already pre- compute part of this information as discussed above. Elements may want to store these update flags (or a subset of these flags) in InternalDataBase::update_each so they know at the time when FiniteElement::fill_fe_values() is called what they are supposed to compute
[in]mappingA reference to the mapping used for computing values and derivatives of shape functions.
[in]quadratureA reference to the object that describes where the shape functions should be evaluated.
[out]output_dataA reference to the object that FEValues will use in conjunction with the object returned here and where an implementation of FiniteElement::fill_fe_values() will place the requested information. This allows the current function to already pre-compute pieces of information that can be computed on the reference cell, as discussed above. FEValues guarantees that this output object and the object returned by the current function will always be used together.
Returns
A pointer to an object of a type derived from InternalDataBase and that derived classes can use to store scratch data that can be pre- computed, or for scratch arrays that then only need to be allocated once. The calling site assumes ownership of this object and will delete it when it is no longer necessary.

Implemented in FE_Enriched< dim, spacedim >, FE_DGPNonparametric< dim, spacedim >, FE_NedelecSZ< dim, spacedim >, FE_Nothing< dim, spacedim >, FE_Nothing< dim, dim >, FE_Poly< dim, spacedim >, FE_Poly< dim, dim >, FE_Poly< dim, spacedim >, FE_PolyFace< PolynomialType, dim, spacedim >, FE_PolyFace< PolynomialSpace< dim - 1 >, dim, dim >, FE_PolyFace< TensorProductPolynomials< dim - 1 >, dim, dim >, FE_PolyTensor< dim, spacedim >, FE_PolyTensor< dim, dim >, FE_PolyTensor< dim, spacedim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ get_face_data() [1/2]

template<int dim, int spacedim = dim>
virtual std::unique_ptr< InternalDataBase > FiniteElement< dim, spacedim >::get_face_data ( const UpdateFlags  update_flags,
const Mapping< dim, spacedim > &  mapping,
const hp::QCollection< dim - 1 > &  quadrature,
::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedvirtual

Like get_data(), but return an object that will later be used for evaluating shape function information at quadrature points on faces of cells. The object will then be used in calls to implementations of FiniteElement::fill_fe_face_values(). See the documentation of get_data() for more information.

The default implementation of this function converts the face quadrature into a cell quadrature with appropriate quadrature point locations, and with that calls the get_data() function above that has to be implemented in derived classes.

Parameters
[in]update_flagsA set of UpdateFlags values that describe what kind of information the FEValues object requests the finite element to compute. This set of flags may also include information that the finite element can not compute, e.g., flags that pertain to data produced by the mapping. An implementation of this function needs to set up all data fields in the returned object that are necessary to produce the finite- element related data specified by these flags, and may already pre- compute part of this information as discussed above. Elements may want to store these update flags (or a subset of these flags) in InternalDataBase::update_each so they know at the time when FiniteElement::fill_fe_face_values() is called what they are supposed to compute
[in]mappingA reference to the mapping used for computing values and derivatives of shape functions.
[in]quadratureA reference to the object that describes where the shape functions should be evaluated.
[out]output_dataA reference to the object that FEValues will use in conjunction with the object returned here and where an implementation of FiniteElement::fill_fe_face_values() will place the requested information. This allows the current function to already pre-compute pieces of information that can be computed on the reference cell, as discussed above. FEValues guarantees that this output object and the object returned by the current function will always be used together.
Returns
A pointer to an object of a type derived from InternalDataBase and that derived classes can use to store scratch data that can be pre- computed, or for scratch arrays that then only need to be allocated once. The calling site assumes ownership of this object and will delete it when it is no longer necessary.

Reimplemented in FE_Enriched< dim, spacedim >, FE_PolyFace< PolynomialType, dim, spacedim >, FE_PolyFace< PolynomialSpace< dim - 1 >, dim, dim >, FE_PolyFace< TensorProductPolynomials< dim - 1 >, dim, dim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ get_face_data() [2/2]

template<int dim, int spacedim = dim>
virtual std::unique_ptr< InternalDataBase > FiniteElement< dim, spacedim >::get_face_data ( const UpdateFlags  update_flags,
const Mapping< dim, spacedim > &  mapping,
const Quadrature< dim - 1 > &  quadrature,
internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedvirtual
Deprecated:
Use the version taking a hp::QCollection argument.

◆ get_subface_data()

template<int dim, int spacedim = dim>
virtual std::unique_ptr< InternalDataBase > FiniteElement< dim, spacedim >::get_subface_data ( const UpdateFlags  update_flags,
const Mapping< dim, spacedim > &  mapping,
const Quadrature< dim - 1 > &  quadrature,
::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedvirtual

Like get_data(), but return an object that will later be used for evaluating shape function information at quadrature points on children of faces of cells. The object will then be used in calls to implementations of FiniteElement::fill_fe_subface_values(). See the documentation of get_data() for more information.

The default implementation of this function converts the face quadrature into a cell quadrature with appropriate quadrature point locations, and with that calls the get_data() function above that has to be implemented in derived classes.

Parameters
[in]update_flagsA set of UpdateFlags values that describe what kind of information the FEValues object requests the finite element to compute. This set of flags may also include information that the finite element can not compute, e.g., flags that pertain to data produced by the mapping. An implementation of this function needs to set up all data fields in the returned object that are necessary to produce the finite- element related data specified by these flags, and may already pre- compute part of this information as discussed above. Elements may want to store these update flags (or a subset of these flags) in InternalDataBase::update_each so they know at the time when FiniteElement::fill_fe_subface_values() is called what they are supposed to compute
[in]mappingA reference to the mapping used for computing values and derivatives of shape functions.
[in]quadratureA reference to the object that describes where the shape functions should be evaluated.
[out]output_dataA reference to the object that FEValues will use in conjunction with the object returned here and where an implementation of FiniteElement::fill_fe_subface_values() will place the requested information. This allows the current function to already pre-compute pieces of information that can be computed on the reference cell, as discussed above. FEValues guarantees that this output object and the object returned by the current function will always be used together.
Returns
A pointer to an object of a type derived from InternalDataBase and that derived classes can use to store scratch data that can be pre- computed, or for scratch arrays that then only need to be allocated once. The calling site assumes ownership of this object and will delete it when it is no longer necessary.

Reimplemented in FE_Enriched< dim, spacedim >, FE_PolyFace< PolynomialType, dim, spacedim >, FE_PolyFace< PolynomialSpace< dim - 1 >, dim, dim >, FE_PolyFace< TensorProductPolynomials< dim - 1 >, dim, dim >, FESystem< dim, spacedim >, FESystem< dim, dim >, and FESystem< dim, spacedim >.

◆ fill_fe_values()

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::fill_fe_values ( const typename Triangulation< dim, spacedim >::cell_iterator &  cell,
const CellSimilarity::Similarity  cell_similarity,
const Quadrature< dim > &  quadrature,
const Mapping< dim, spacedim > &  mapping,
const typename Mapping< dim, spacedim >::InternalDataBase &  mapping_internal,
const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &  mapping_data,
const InternalDataBase fe_internal,
::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedpure virtual

Compute information about the shape functions on the cell denoted by the first argument. Derived classes will have to implement this function based on the kind of element they represent. It is called by FEValues::reinit().

Conceptually, this function evaluates shape functions and their derivatives at the quadrature points represented by the mapped locations of those described by the quadrature argument to this function. In many cases, computing derivatives of shape functions (and in some cases also computing values of shape functions) requires making use of the mapping from the reference to the real cell; this information can either be taken from the mapping_data object that has been filled for the current cell before this function is called, or by calling the member functions of a Mapping object with the mapping_internal object that also corresponds to the current cell.

The information computed by this function is used to fill the various member variables of the output argument of this function. Which of the member variables of that structure should be filled is determined by the update flags stored in the FiniteElement::InternalDataBase::update_each field of the object passed to this function. These flags are typically set by FiniteElement::get_data(), FiniteElement::get_face_date() and FiniteElement::get_subface_data() (or, more specifically, implementations of these functions in derived classes).

An extensive discussion of the interaction between this function and FEValues can be found in the How Mapping, FiniteElement, and FEValues work together documentation module.

Parameters
[in]cellThe cell of the triangulation for which this function is to compute a mapping from the reference cell to.
[in]cell_similarityWhether or not the cell given as first argument is simply a translation, rotation, etc of the cell for which this function was called the most recent time. This information is computed simply by matching the vertices (as stored by the Triangulation) between the previous and the current cell. The value passed here may be modified by implementations of this function and should then be returned (see the discussion of the return value of this function).
[in]quadratureA reference to the quadrature formula in use for the current evaluation. This quadrature object is the same as the one used when creating the internal_data object. The current object is then responsible for evaluating shape functions at the mapped locations of the quadrature points represented by this object.
[in]mappingA reference to the mapping object used to map from the reference cell to the current cell. This object was used to compute the information in the mapping_data object before the current function was called. It is also the mapping object that created the mapping_internal object via Mapping::get_data(). You will need the reference to this mapping object most often to call Mapping::transform() to transform gradients and higher derivatives from the reference to the current cell.
[in]mapping_internalAn object specific to the mapping object. What the mapping chooses to store in there is of no relevance to the current function, but you may have to pass a reference to this object to certain functions of the Mapping class (e.g., Mapping::transform()) if you need to call them from the current function.
[in]mapping_dataThe output object into which the Mapping::fill_fe_values() function wrote the mapping information corresponding to the current cell. This includes, for example, Jacobians of the mapping that may be of relevance to the current function, as well as other information that FEValues::reinit() requested from the mapping.
[in]fe_internalA reference to an object previously created by get_data() and that may be used to store information the mapping can compute once on the reference cell. See the documentation of the FiniteElement::InternalDataBase class for an extensive description of the purpose of these objects.
[out]output_dataA reference to an object whose member variables should be computed. Not all of the members of this argument need to be filled; which ones need to be filled is determined by the update flags stored inside the fe_internal object.
Note
FEValues ensures that this function is always called with the same pair of fe_internal and output_data objects. In other words, if an implementation of this function knows that it has written a piece of data into the output argument in a previous call, then there is no need to copy it there again in a later call if the implementation knows that this is the same value.

◆ fill_fe_face_values() [1/2]

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::fill_fe_face_values ( const typename Triangulation< dim, spacedim >::cell_iterator &  cell,
const unsigned int  face_no,
const hp::QCollection< dim - 1 > &  quadrature,
const Mapping< dim, spacedim > &  mapping,
const typename Mapping< dim, spacedim >::InternalDataBase &  mapping_internal,
const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &  mapping_data,
const InternalDataBase fe_internal,
::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedvirtual

This function is the equivalent to FiniteElement::fill_fe_values(), but for faces of cells. See there for an extensive discussion of its purpose. It is called by FEFaceValues::reinit().

Parameters
[in]cellThe cell of the triangulation for which this function is to compute a mapping from the reference cell to.
[in]face_noThe number of the face we are currently considering, indexed among the faces of the cell specified by the previous argument.
[in]quadratureA reference to the quadrature formula in use for the current evaluation. This quadrature object is the same as the one used when creating the internal_data object. The current object is then responsible for evaluating shape functions at the mapped locations of the quadrature points represented by this object.
[in]mappingA reference to the mapping object used to map from the reference cell to the current cell. This object was used to compute the information in the mapping_data object before the current function was called. It is also the mapping object that created the mapping_internal object via Mapping::get_data(). You will need the reference to this mapping object most often to call Mapping::transform() to transform gradients and higher derivatives from the reference to the current cell.
[in]mapping_internalAn object specific to the mapping object. What the mapping chooses to store in there is of no relevance to the current function, but you may have to pass a reference to this object to certain functions of the Mapping class (e.g., Mapping::transform()) if you need to call them from the current function.
[in]mapping_dataThe output object into which the Mapping::fill_fe_values() function wrote the mapping information corresponding to the current cell. This includes, for example, Jacobians of the mapping that may be of relevance to the current function, as well as other information that FEValues::reinit() requested from the mapping.
[in]fe_internalA reference to an object previously created by get_data() and that may be used to store information the mapping can compute once on the reference cell. See the documentation of the FiniteElement::InternalDataBase class for an extensive description of the purpose of these objects.
[out]output_dataA reference to an object whose member variables should be computed. Not all of the members of this argument need to be filled; which ones need to be filled is determined by the update flags stored inside the fe_internal object.

◆ fill_fe_face_values() [2/2]

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::fill_fe_face_values ( const typename Triangulation< dim, spacedim >::cell_iterator &  cell,
const unsigned int  face_no,
const Quadrature< dim - 1 > &  quadrature,
const Mapping< dim, spacedim > &  mapping,
const typename Mapping< dim, spacedim >::InternalDataBase &  mapping_internal,
const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &  mapping_data,
const InternalDataBase fe_internal,
internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedvirtual
Deprecated:
Use the version taking a hp::QCollection argument.

◆ fill_fe_subface_values()

template<int dim, int spacedim = dim>
virtual void FiniteElement< dim, spacedim >::fill_fe_subface_values ( const typename Triangulation< dim, spacedim >::cell_iterator &  cell,
const unsigned int  face_no,
const unsigned int  sub_no,
const Quadrature< dim - 1 > &  quadrature,
const Mapping< dim, spacedim > &  mapping,
const typename Mapping< dim, spacedim >::InternalDataBase &  mapping_internal,
const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &  mapping_data,
const InternalDataBase fe_internal,
::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &  output_data 
) const
protectedpure virtual

This function is the equivalent to FiniteElement::fill_fe_values(), but for the children of faces of cells. See there for an extensive discussion of its purpose. It is called by FESubfaceValues::reinit().

Parameters
[in]cellThe cell of the triangulation for which this function is to compute a mapping from the reference cell to.
[in]face_noThe number of the face we are currently considering, indexed among the faces of the cell specified by the previous argument.
[in]sub_noThe number of the subface, i.e., the number of the child of a face, that we are currently considering, indexed among the children of the face specified by the previous argument.
[in]quadratureA reference to the quadrature formula in use for the current evaluation. This quadrature object is the same as the one used when creating the internal_data object. The current object is then responsible for evaluating shape functions at the mapped locations of the quadrature points represented by this object.
[in]mappingA reference to the mapping object used to map from the reference cell to the current cell. This object was used to compute the information in the mapping_data object before the current function was called. It is also the mapping object that created the mapping_internal object via Mapping::get_data(). You will need the reference to this mapping object most often to call Mapping::transform() to transform gradients and higher derivatives from the reference to the current cell.
[in]mapping_internalAn object specific to the mapping object. What the mapping chooses to store in there is of no relevance to the current function, but you may have to pass a reference to this object to certain functions of the Mapping class (e.g., Mapping::transform()) if you need to call them from the current function.
[in]mapping_dataThe output object into which the Mapping::fill_fe_values() function wrote the mapping information corresponding to the current cell. This includes, for example, Jacobians of the mapping that may be of relevance to the current function, as well as other information that FEValues::reinit() requested from the mapping.
[in]fe_internalA reference to an object previously created by get_data() and that may be used to store information the mapping can compute once on the reference cell. See the documentation of the FiniteElement::InternalDataBase class for an extensive description of the purpose of these objects.
[out]output_dataA reference to an object whose member variables should be computed. Not all of the members of this argument need to be filled; which ones need to be filled is determined by the update flags stored inside the fe_internal object.

◆ subscribe()

void Subscriptor::subscribe ( std::atomic< bool > *const  validity,
const std::string &  identifier = "" 
) const
inherited

Subscribes a user of the object by storing the pointer validity. The subscriber may be identified by text supplied as identifier.

Definition at line 136 of file subscriptor.cc.

◆ unsubscribe()

void Subscriptor::unsubscribe ( std::atomic< bool > *const  validity,
const std::string &  identifier = "" 
) const
inherited

Unsubscribes a user from the object.

Note
The identifier and the validity pointer must be the same as the one supplied to subscribe().

Definition at line 156 of file subscriptor.cc.

◆ n_subscriptions()

unsigned int Subscriptor::n_subscriptions ( ) const
inlineinherited

Return the present number of subscriptions to this object. This allows to use this class for reference counted lifetime determination where the last one to unsubscribe also deletes the object.

Definition at line 300 of file subscriptor.h.

◆ list_subscribers() [1/2]

template<typename StreamType >
void Subscriptor::list_subscribers ( StreamType &  stream) const
inlineinherited

List the subscribers to the input stream.

Definition at line 317 of file subscriptor.h.

◆ list_subscribers() [2/2]

void Subscriptor::list_subscribers ( ) const
inherited

List the subscribers to deallog.

Definition at line 204 of file subscriptor.cc.

◆ serialize()

template<class Archive >
void Subscriptor::serialize ( Archive &  ar,
const unsigned int  version 
)
inlineinherited

Read or write the data of this object to or from a stream for the purpose of serialization using the BOOST serialization library.

This function does not actually serialize any of the member variables of this class. The reason is that what this class stores is only who subscribes to this object, but who does so at the time of storing the contents of this object does not necessarily have anything to do with who subscribes to the object when it is restored. Consequently, we do not want to overwrite the subscribers at the time of restoring, and then there is no reason to write the subscribers out in the first place.

Definition at line 309 of file subscriptor.h.

◆ check_no_subscribers()

void Subscriptor::check_no_subscribers ( ) const
privatenoexceptinherited

Check that there are no objects subscribing to this object. If this check passes then it is safe to destroy the current object. It this check fails then this function will either abort or print an error message to deallog (by using the AssertNothrow mechanism), but will not throw an exception.

Note
Since this function is just a consistency check it does nothing in release mode.
If this function is called when there is an uncaught exception then, rather than aborting, this function prints an error message to the standard error stream and returns.

Definition at line 53 of file subscriptor.cc.

◆ reference_cell()

template<int dim>
ReferenceCell FiniteElementData< dim >::reference_cell ( ) const
inherited

Return the kind of reference cell this element is defined on: For example, whether the element's reference cell is a square or triangle, or similar choices in higher dimensions.

◆ n_unique_2d_subobjects()

template<int dim>
unsigned int FiniteElementData< dim >::n_unique_2d_subobjects ( ) const
inherited

Number of unique 2d subobjects. If all two-dimensional subobjects are of the same kind, the value is one; else it equals the number of two-dimensional subobjects. For example, for hex reference cells with the usual finite elements, each face has the same geometric shape (a square) and each face has the same number and kind of shape functions associated with it; as a consequence, the returned value is one. On the other hand, for a wedge element, the two-dimensional subobjects can be both quadrilaterals and triangles, and so the returned value equals the number of faces of these objects (i.e., five).

◆ n_unique_faces()

template<int dim>
unsigned int FiniteElementData< dim >::n_unique_faces ( ) const
inherited

Number of unique faces. If all faces have the same type (i.e., have the same shape and also have the same kind and number of DoFs associated with them), the value is one; else it equals the number of faces.

◆ n_dofs_per_vertex()

template<int dim>
unsigned int FiniteElementData< dim >::n_dofs_per_vertex ( ) const
inherited

Number of dofs per vertex.

◆ n_dofs_per_line()

template<int dim>
unsigned int FiniteElementData< dim >::n_dofs_per_line ( ) const
inherited

Number of dofs per line. Not including dofs on lower dimensional objects.

◆ n_dofs_per_quad()

template<int dim>
unsigned int FiniteElementData< dim >::n_dofs_per_quad ( unsigned int  face_no = 0) const
inherited

Number of dofs per quad. Not including dofs on lower dimensional objects.

◆ max_dofs_per_quad()

template<int dim>
unsigned int FiniteElementData< dim >::max_dofs_per_quad ( ) const
inherited

Maximum number of dofs per quad. Not including dofs on lower dimensional objects.

◆ n_dofs_per_hex()

template<int dim>
unsigned int FiniteElementData< dim >::n_dofs_per_hex ( ) const
inherited

Number of dofs per hex. Not including dofs on lower dimensional objects.

◆ n_dofs_per_face()

template<int dim>
unsigned int FiniteElementData< dim >::n_dofs_per_face ( unsigned int  face_no = 0,
unsigned int  child = 0 
) const
inherited

Number of dofs per face, accumulating degrees of freedom of all lower dimensional objects.

◆ max_dofs_per_face()

template<int dim>
unsigned int FiniteElementData< dim >::max_dofs_per_face ( ) const
inherited

Maximum number of dofs per face, accumulating degrees of freedom of all lower dimensional objects.

◆ n_dofs_per_cell()

template<int dim>
unsigned int FiniteElementData< dim >::n_dofs_per_cell ( ) const
inherited

Number of dofs per cell, accumulating degrees of freedom of all lower dimensional objects.

◆ n_dofs_per_object()

template<int dim>
template<int structdim>
unsigned int FiniteElementData< dim >::n_dofs_per_object ( const unsigned int  i = 0) const
inherited

Return the number of degrees per structdim-dimensional object. For structdim==0, the function therefore returns dofs_per_vertex, for structdim==1 dofs_per_line, etc. This function is mostly used to allow some template trickery for functions that should work on all sorts of objects without wanting to use the different names (vertex, line, ...) associated with these objects.

◆ n_components()

template<int dim>
unsigned int FiniteElementData< dim >::n_components ( ) const
inherited

Number of components. See the glossary for more information.

◆ n_blocks()

template<int dim>
unsigned int FiniteElementData< dim >::n_blocks ( ) const
inherited

Number of blocks. See the glossary for more information.

◆ block_indices()

template<int dim>
const BlockIndices & FiniteElementData< dim >::block_indices ( ) const
inherited

Detailed information on block sizes.

◆ tensor_degree()

template<int dim>
unsigned int FiniteElementData< dim >::tensor_degree ( ) const
inherited

Maximal polynomial degree of a shape function in a single coordinate direction.

This function can be used to determine the optimal quadrature rule.

◆ conforms()

template<int dim>
bool FiniteElementData< dim >::conforms ( const Conformity  ) const
inherited

Test whether a finite element space conforms to a certain Sobolev space.

Note
This function will return a true value even if the finite element space has higher regularity than asked for.

◆ operator==() [2/2]

template<int dim>
bool FiniteElementData< dim >::operator== ( const FiniteElementData< dim > &  f) const
inherited

Comparison operator.

Definition at line 196 of file fe_data.cc.

◆ get_first_line_index()

template<int dim>
unsigned int FiniteElementData< dim >::get_first_line_index ( ) const
inherited

Return first index of dof on a line.

◆ get_first_quad_index()

template<int dim>
unsigned int FiniteElementData< dim >::get_first_quad_index ( const unsigned int  quad_no = 0) const
inherited

Return first index of dof on a quad.

◆ get_first_hex_index()

template<int dim>
unsigned int FiniteElementData< dim >::get_first_hex_index ( ) const
inherited

Return first index of dof on a hexahedron.

◆ get_first_face_line_index()

template<int dim>
unsigned int FiniteElementData< dim >::get_first_face_line_index ( const unsigned int  face_no = 0) const
inherited

Return first index of dof on a line for face data.

◆ get_first_face_quad_index()

template<int dim>
unsigned int FiniteElementData< dim >::get_first_face_quad_index ( const unsigned int  face_no = 0) const
inherited

Return first index of dof on a quad for face data.

Friends And Related Symbol Documentation

◆ InternalDataBase

template<int dim, int spacedim = dim>
friend class InternalDataBase
friend

Definition at line 3061 of file fe.h.

◆ FEValuesBase< dim, spacedim >

template<int dim, int spacedim = dim>
friend class FEValuesBase< dim, spacedim >
friend

Definition at line 3061 of file fe.h.

◆ FEValues< dim, spacedim >

template<int dim, int spacedim = dim>
friend class FEValues< dim, spacedim >
friend

Definition at line 3061 of file fe.h.

◆ FEFaceValues< dim, spacedim >

template<int dim, int spacedim = dim>
friend class FEFaceValues< dim, spacedim >
friend

Definition at line 3061 of file fe.h.

◆ FESubfaceValues< dim, spacedim >

template<int dim, int spacedim = dim>
friend class FESubfaceValues< dim, spacedim >
friend

Definition at line 3061 of file fe.h.

◆ NonMatching::FEImmersedSurfaceValues< dim >

template<int dim, int spacedim = dim>
friend class NonMatching::FEImmersedSurfaceValues< dim >
friend

Definition at line 3061 of file fe.h.

◆ FESystem< dim, spacedim >

template<int dim, int spacedim = dim>
friend class FESystem< dim, spacedim >
friend

Definition at line 3061 of file fe.h.

Member Data Documentation

◆ space_dimension

template<int dim, int spacedim = dim>
constexpr unsigned int FiniteElement< dim, spacedim >::space_dimension = spacedim
staticconstexpr

The dimension of the image space, corresponding to Triangulation.

Definition at line 661 of file fe.h.

◆ restriction

template<int dim, int spacedim = dim>
std::vector<std::vector<FullMatrix<double> > > FiniteElement< dim, spacedim >::restriction
protected

Vector of projection matrices. See get_restriction_matrix() above. The constructor initializes these matrices to zero dimensions, which can be changed by derived classes implementing them.

Note, that restriction[refinement_case-1][child] includes the restriction matrix of child child for the RefinementCase refinement_case. Here, we use refinement_case-1 instead of refinement_case as for RefinementCase::no_refinement(=0) there are no restriction matrices available.

Definition at line 2402 of file fe.h.

◆ prolongation

template<int dim, int spacedim = dim>
std::vector<std::vector<FullMatrix<double> > > FiniteElement< dim, spacedim >::prolongation
protected

Vector of embedding matrices. See get_prolongation_matrix() above. The constructor initializes these matrices to zero dimensions, which can be changed by derived classes implementing them.

Note, that prolongation[refinement_case-1][child] includes the prolongation matrix of child child for the RefinementCase refinement_case. Here, we use refinement_case-1 instead of refinement_case as for RefinementCase::no_refinement(=0) there are no prolongation matrices available.

Definition at line 2416 of file fe.h.

◆ interface_constraints

template<int dim, int spacedim = dim>
FullMatrix<double> FiniteElement< dim, spacedim >::interface_constraints
protected

Specify the constraints which the dofs on the two sides of a cell interface underlie if the line connects two cells of which one is refined once.

For further details see the general description of the derived class.

This field is obviously useless in one dimension and has there a zero size.

Definition at line 2428 of file fe.h.

◆ unit_support_points

template<int dim, int spacedim = dim>
std::vector<Point<dim> > FiniteElement< dim, spacedim >::unit_support_points
protected

List of support points on the unit cell, in case the finite element has any. The constructor leaves this field empty, derived classes may write in some contents.

Finite elements that allow some kind of interpolation operation usually have support points. On the other hand, elements that define their degrees of freedom by, for example, moments on faces, or as derivatives, don't have support points. In that case, this field remains empty.

Definition at line 2440 of file fe.h.

◆ unit_face_support_points

template<int dim, int spacedim = dim>
std::vector<std::vector<Point<dim - 1> > > FiniteElement< dim, spacedim >::unit_face_support_points
protected

Same for the faces. See the description of the get_unit_face_support_points() function for a discussion of what contributes a face support point.

Definition at line 2447 of file fe.h.

◆ generalized_support_points

template<int dim, int spacedim = dim>
std::vector<Point<dim> > FiniteElement< dim, spacedim >::generalized_support_points
protected

Support points used for interpolation functions of non-Lagrangian elements.

Definition at line 2453 of file fe.h.

◆ generalized_face_support_points

template<int dim, int spacedim = dim>
std::vector<std::vector<Point<dim - 1> > > FiniteElement< dim, spacedim >::generalized_face_support_points
protected

Face support points used for interpolation functions of non-Lagrangian elements.

Definition at line 2459 of file fe.h.

◆ adjust_quad_dof_index_for_face_orientation_table

template<int dim, int spacedim = dim>
std::vector<Table<2, int> > FiniteElement< dim, spacedim >::adjust_quad_dof_index_for_face_orientation_table
protected

For faces with non-standard face_orientation in 3d, the dofs on faces (quads) have to be permuted in order to be combined with the correct shape functions. Given a local dof index on a quad, return the shift in the local index, if the face has non-standard face_orientation, i.e. old_index + shift = new_index. In 2d and 1d there is no need for permutation so the vector is empty. In 3d it has the size of dofs_per_quad * 8 , where 8 is the number of orientations, a face can be in (all combinations of the three bool flags face_orientation, face_flip and face_rotation).

The constructor of this class fills this table with zeros, i.e., no permutation at all. Derived finite element classes have to fill this Table with the correct values.

Definition at line 2476 of file fe.h.

◆ adjust_line_dof_index_for_line_orientation_table

template<int dim, int spacedim = dim>
std::vector<int> FiniteElement< dim, spacedim >::adjust_line_dof_index_for_line_orientation_table
protected

For lines with non-standard line_orientation in 3d, the dofs on lines have to be permuted in order to be combined with the correct shape functions. Given a local dof index on a line, return the shift in the local index, if the line has non-standard line_orientation, i.e. old_index + shift = new_index. In 2d and 1d there is no need for permutation so the vector is empty. In 3d it has the size of dofs_per_line.

The constructor of this class fills this table with zeros, i.e., no permutation at all. Derived finite element classes have to fill this vector with the correct values.

Definition at line 2491 of file fe.h.

◆ system_to_component_table

template<int dim, int spacedim = dim>
std::vector<std::pair<unsigned int, unsigned int> > FiniteElement< dim, spacedim >::system_to_component_table
protected

Store what system_to_component_index() will return.

Definition at line 2496 of file fe.h.

◆ face_system_to_component_table

template<int dim, int spacedim = dim>
std::vector<std::vector<std::pair<unsigned int, unsigned int> > > FiniteElement< dim, spacedim >::face_system_to_component_table
protected

Map between linear dofs and component dofs on face. This is filled with default values in the constructor, but derived classes will have to overwrite the information if necessary.

By component, we mean the vector component, not the base element. The information thus makes only sense if a shape function is non-zero in only one component.

Definition at line 2508 of file fe.h.

◆ system_to_base_table

template<int dim, int spacedim = dim>
std::vector<std::pair<std::pair<unsigned int, unsigned int>, unsigned int> > FiniteElement< dim, spacedim >::system_to_base_table
protected

For each shape function, store to which base element and which instance of this base element (in case its multiplicity is greater than one) it belongs, and its index within this base element. If the element is not composed of others, then base and instance are always zero, and the index is equal to the number of the shape function. If the element is composed of single instances of other elements (i.e. all with multiplicity one) all of which are scalar, then base values and dof indices within this element are equal to the system_to_component_table. It differs only in case the element is composed of other elements and at least one of them is vector-valued itself.

This array has valid values also in the case of vector-valued (i.e. non-primitive) shape functions, in contrast to the system_to_component_table.

Definition at line 2527 of file fe.h.

◆ face_system_to_base_table

template<int dim, int spacedim = dim>
std::vector< std::vector<std::pair<std::pair<unsigned int, unsigned int>, unsigned int> > > FiniteElement< dim, spacedim >::face_system_to_base_table
protected

Likewise for the indices on faces.

Definition at line 2534 of file fe.h.

◆ base_to_block_indices

template<int dim, int spacedim = dim>
BlockIndices FiniteElement< dim, spacedim >::base_to_block_indices
protected

For each base element, store the number of blocks generated by the base and the first block in a block vector it will generate.

Definition at line 2540 of file fe.h.

◆ component_to_base_table

template<int dim, int spacedim = dim>
std::vector<std::pair<std::pair<unsigned int, unsigned int>, unsigned int> > FiniteElement< dim, spacedim >::component_to_base_table
protected

The base element establishing a component.

For each component number c, the entries have the following meaning:

table[c].first.first
Number of the base element for c. This is the index you can pass to base_element().
table[c].first.second
Component within the base element for c. This value is between 0 and the n_components() of this base element.
table[c].second
Index of the multiple of the base element that contains c. This value is between 0 and the element_multiplicity() of this base element.

This variable is set to the correct size by the constructor of this class, but needs to be initialized by derived classes, unless its size is one and the only entry is a zero, which is the case for scalar elements. In that case, the initialization by the base class is sufficient.

Note
This table is filled by FETools::Compositing::build_cell_tables().

Definition at line 2563 of file fe.h.

◆ restriction_is_additive_flags

template<int dim, int spacedim = dim>
const std::vector<bool> FiniteElement< dim, spacedim >::restriction_is_additive_flags
protected

A flag determining whether restriction matrices are to be concatenated or summed up. See the discussion about restriction matrices in the general class documentation for more information.

Definition at line 2570 of file fe.h.

◆ nonzero_components

template<int dim, int spacedim = dim>
const std::vector<ComponentMask> FiniteElement< dim, spacedim >::nonzero_components
protected

For each shape function, give a vector of bools (with size equal to the number of vector components which this finite element has) indicating in which component each of these shape functions is non-zero.

For primitive elements, there is only one non-zero component.

Definition at line 2579 of file fe.h.

◆ n_nonzero_components_table

template<int dim, int spacedim = dim>
const std::vector<unsigned int> FiniteElement< dim, spacedim >::n_nonzero_components_table
protected

This array holds how many values in the respective entry of the nonzero_components element are non-zero. The array is thus a short-cut to allow faster access to this information than if we had to count the non-zero entries upon each request for this information. The field is initialized in the constructor of this class.

Definition at line 2588 of file fe.h.

◆ cached_primitivity

template<int dim, int spacedim = dim>
const bool FiniteElement< dim, spacedim >::cached_primitivity
protected

Store whether all shape functions are primitive. Since finding this out is a very common operation, we cache the result, i.e. compute the value in the constructor for simpler access.

Definition at line 2595 of file fe.h.

◆ counter

std::atomic<unsigned int> Subscriptor::counter
mutableprivateinherited

Store the number of objects which subscribed to this object. Initially, this number is zero, and upon destruction it shall be zero again (i.e. all objects which subscribed should have unsubscribed again).

The creator (and owner) of an object is counted in the map below if HE manages to supply identification.

We use the mutable keyword in order to allow subscription to constant objects also.

This counter may be read from and written to concurrently in multithreaded code: hence we use the std::atomic class template.

Definition at line 219 of file subscriptor.h.

◆ counter_map

std::map<std::string, unsigned int> Subscriptor::counter_map
mutableprivateinherited

In this map, we count subscriptions for each different identification string supplied to subscribe().

Definition at line 225 of file subscriptor.h.

◆ validity_pointers

std::vector<std::atomic<bool> *> Subscriptor::validity_pointers
mutableprivateinherited

In this vector, we store pointers to the validity bool in the SmartPointer objects that subscribe to this class.

Definition at line 241 of file subscriptor.h.

◆ object_info

const std::type_info* Subscriptor::object_info
mutableprivateinherited

Pointer to the typeinfo object of this object, from which we can later deduce the class name. Since this information on the derived class is neither available in the destructor, nor in the constructor, we obtain it in between and store it here.

Definition at line 249 of file subscriptor.h.

◆ mutex

std::mutex Subscriptor::mutex
staticprivateinherited

A mutex used to ensure data consistency when printing out the list of subscribers.

Definition at line 271 of file subscriptor.h.

◆ dimension

template<int dim>
constexpr unsigned int FiniteElementData< dim >::dimension = dim
staticconstexprinherited

The dimension of the finite element, which is the template parameter dim

Definition at line 302 of file fe_data.h.

◆ reference_cell_kind

template<int dim>
const ReferenceCell FiniteElementData< dim >::reference_cell_kind
privateinherited

Reference cell type.

Definition at line 308 of file fe_data.h.

◆ number_of_unique_2d_subobjects

template<int dim>
const unsigned int FiniteElementData< dim >::number_of_unique_2d_subobjects
privateinherited

Number of unique two-dimensional sub-objects. If all two-dimensional sub-objects have the same type, the value is one; else it equals the number of quads.

Definition at line 315 of file fe_data.h.

◆ number_unique_faces

template<int dim>
const unsigned int FiniteElementData< dim >::number_unique_faces
privateinherited

Number of unique faces. If all faces have the same type, the value is one; else it equals the number of faces.

Definition at line 321 of file fe_data.h.

◆ dofs_per_vertex

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_vertex
inherited

Number of degrees of freedom on a vertex.

Definition at line 327 of file fe_data.h.

◆ dofs_per_line

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_line
inherited

Number of degrees of freedom in a line; not including the degrees of freedom on the vertices of the line.

Definition at line 333 of file fe_data.h.

◆ n_dofs_on_quad

template<int dim>
const std::vector<unsigned int> FiniteElementData< dim >::n_dofs_on_quad
privateinherited

Number of degrees of freedom on quads. If all quads have the same number of degrees freedoms the values equal dofs_per_quad.

Definition at line 340 of file fe_data.h.

◆ dofs_per_quad

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_quad
inherited

Number of degrees of freedom in a quadrilateral; not including the degrees of freedom on the lines and vertices of the quadrilateral.

Definition at line 347 of file fe_data.h.

◆ dofs_per_quad_max

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_quad_max
privateinherited

Maximum number of degrees of freedom on any quad.

Definition at line 353 of file fe_data.h.

◆ dofs_per_hex

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_hex
inherited

Number of degrees of freedom in a hexahedron; not including the degrees of freedom on the quadrilaterals, lines and vertices of the hexahedron.

Definition at line 360 of file fe_data.h.

◆ first_line_index

template<int dim>
const unsigned int FiniteElementData< dim >::first_line_index
inherited

First index of dof on a line.

Definition at line 365 of file fe_data.h.

◆ first_index_of_quads

template<int dim>
const std::vector<unsigned int> FiniteElementData< dim >::first_index_of_quads
privateinherited

First index of a quad. If all quads have the same number of degrees of freedom, only the first index of the first quad is stored since the indices of the others can be simply recomputed.

Definition at line 373 of file fe_data.h.

◆ first_quad_index

template<int dim>
const unsigned int FiniteElementData< dim >::first_quad_index
inherited

First index of dof on a quad.

Definition at line 379 of file fe_data.h.

◆ first_hex_index

template<int dim>
const unsigned int FiniteElementData< dim >::first_hex_index
inherited

First index of dof on a hexahedron.

Definition at line 384 of file fe_data.h.

◆ first_line_index_of_faces

template<int dim>
const std::vector<unsigned int> FiniteElementData< dim >::first_line_index_of_faces
privateinherited

Index of the first line of all faces.

Definition at line 390 of file fe_data.h.

◆ first_face_line_index

template<int dim>
const unsigned int FiniteElementData< dim >::first_face_line_index
inherited

First index of dof on a line for face data.

Definition at line 396 of file fe_data.h.

◆ first_quad_index_of_faces

template<int dim>
const std::vector<unsigned int> FiniteElementData< dim >::first_quad_index_of_faces
privateinherited

Index of the first quad of all faces.

Definition at line 402 of file fe_data.h.

◆ first_face_quad_index

template<int dim>
const unsigned int FiniteElementData< dim >::first_face_quad_index
inherited

First index of dof on a quad for face data.

Definition at line 408 of file fe_data.h.

◆ n_dofs_on_face

template<int dim>
const std::vector<unsigned int> FiniteElementData< dim >::n_dofs_on_face
privateinherited

Number of degrees of freedom on faces. If all faces have the same number of degrees freedoms the values equal dofs_per_quad.

Definition at line 415 of file fe_data.h.

◆ dofs_per_face

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_face
inherited

Number of degrees of freedom on a face. This is the accumulated number of degrees of freedom on all the objects of dimension up to dim-1 constituting a face.

Definition at line 423 of file fe_data.h.

◆ dofs_per_face_max

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_face_max
privateinherited

Maximum number of degrees of freedom on any face.

Definition at line 429 of file fe_data.h.

◆ dofs_per_cell

template<int dim>
const unsigned int FiniteElementData< dim >::dofs_per_cell
inherited

Total number of degrees of freedom on a cell. This is the accumulated number of degrees of freedom on all the objects of dimension up to dim constituting a cell.

Definition at line 437 of file fe_data.h.

◆ components

template<int dim>
const unsigned int FiniteElementData< dim >::components
inherited

Number of vector components of this finite element, and dimension of the image space. For vector-valued finite elements (i.e. when this number is greater than one), the number of vector components is in many cases equal to the number of base elements glued together with the help of the FESystem class. However, for elements like the Nedelec element, the number is greater than one even though we only have one base element.

Definition at line 447 of file fe_data.h.

◆ degree

template<int dim>
const unsigned int FiniteElementData< dim >::degree
inherited

Maximal polynomial degree of a shape function in a single coordinate direction.

Definition at line 453 of file fe_data.h.

◆ conforming_space

template<int dim>
const Conformity FiniteElementData< dim >::conforming_space
inherited

Indicate the space this element conforms to.

Definition at line 458 of file fe_data.h.

◆ block_indices_data

template<int dim>
const BlockIndices FiniteElementData< dim >::block_indices_data
inherited

Storage for an object describing the sizes of each block of a compound element. For an element which is not an FESystem, this contains only a single block with length dofs_per_cell.

Definition at line 465 of file fe_data.h.


The documentation for this class was generated from the following file: