Flow123d  release_3.0.0-869-g0e4dab6
Public Member Functions | List of all members
FEValues< dim, spacedim > Class Template Reference

Calculates finite element data on the actual cell. More...

#include <fe_values.hh>

Inheritance diagram for FEValues< dim, spacedim >:
Inheritance graph
[legend]
Collaboration diagram for FEValues< dim, spacedim >:
Collaboration graph
[legend]

Public Member Functions

 FEValues (Mapping< dim, spacedim > &_mapping, Quadrature< dim > &_quadrature, FiniteElement< dim > &_fe, UpdateFlags _flags)
 Constructor. More...
 
void reinit (ElementAccessor< 3 > &cell)
 Update cell-dependent data (gradients, Jacobians etc.) More...
 
- Public Member Functions inherited from FEValuesBase< dim, spacedim >
 FEValuesBase ()
 Default constructor. More...
 
virtual ~FEValuesBase ()
 
void allocate (Mapping< dim, spacedim > &_mapping, Quadrature< dim > &_quadrature, FiniteElement< dim > &_fe, UpdateFlags flags)
 Allocates space for computed data. More...
 
UpdateFlags update_each (UpdateFlags flags)
 Determine quantities to be recomputed on each cell. More...
 
double shape_value (const unsigned int function_no, const unsigned int point_no)
 Return the value of the function_no-th shape function at the point_no-th quadrature point. More...
 
arma::vec::fixed< spacedim > shape_grad (const unsigned int function_no, const unsigned int point_no)
 Return the gradient of the function_no-th shape function at the point_no-th quadrature point. More...
 
double shape_value_component (const unsigned int function_no, const unsigned int point_no, const unsigned int comp) const
 Return the value of the function_no-th shape function at the point_no-th quadrature point. More...
 
arma::vec::fixed< spacedim > shape_grad_component (const unsigned int function_no, const unsigned int point_no, const unsigned int comp) const
 Return the gradient of the function_no-th shape function at the point_no-th quadrature point. More...
 
double determinant (const unsigned int point_no)
 Return the relative volume change of the cell (Jacobian determinant). More...
 
double JxW (const unsigned int point_no)
 Return the product of Jacobian determinant and the quadrature weight at given quadrature point. More...
 
arma::vec::fixed< spacedim > point (const unsigned int point_no)
 Return coordinates of the quadrature point in the actual cell system. More...
 
vector< arma::vec::fixed< spacedim > > & point_list ()
 Return coordinates of all quadrature points in the actual cell system. More...
 
arma::vec::fixed< spacedim > normal_vector (unsigned int point_no)
 Returns the normal vector to a side at given quadrature point. More...
 
const FEValuesViews::Scalar< dim, spacedim > & scalar_view (unsigned int i) const
 Accessor to scalar values of multicomponent FE. More...
 
const FEValuesViews::Vector< dim, spacedim > & vector_view (unsigned int i) const
 Accessor to vector values of multicomponent FE. More...
 
const FEValuesViews::Tensor< dim, spacedim > & tensor_view (unsigned int i) const
 Accessor to tensor values of multicomponent FE. More...
 
unsigned int n_points ()
 Returns the number of quadrature points. More...
 
unsigned int n_dofs ()
 Returns the number of shape functions. More...
 
Quadrature< dim > * get_quadrature () const
 Returns the quadrature in use. More...
 
FiniteElement< dim > * get_fe () const
 Returns the finite element in use. More...
 
Mapping< dim, spacedim > * get_mapping () const
 Returns the mapping in use. More...
 
- Public Member Functions inherited from FEValuesSpaceBase< spacedim >
virtual ~FEValuesSpaceBase ()
 

Additional Inherited Members

- Protected Member Functions inherited from FEValuesBase< dim, spacedim >
FEInternalDatainit_fe_data (const Quadrature< dim > *q)
 Precompute finite element data on reference element. More...
 
void fill_data (const FEInternalData &fe_data)
 Computes the shape function values and gradients on the actual cell and fills the FEValues structure. More...
 
void fill_scalar_data (const FEInternalData &fe_data)
 Compute shape functions and gradients on the actual cell for scalar FE. More...
 
void fill_vec_data (const FEInternalData &fe_data)
 Compute shape functions and gradients on the actual cell for vectorial FE. More...
 
void fill_vec_contravariant_data (const FEInternalData &fe_data)
 Compute shape functions and gradients on the actual cell for vectorial FE. More...
 
void fill_vec_piola_data (const FEInternalData &fe_data)
 Compute shape functions and gradients on the actual cell for Raviart-Thomas FE. More...
 
void fill_tensor_data (const FEInternalData &fe_data)
 Compute shape functions and gradients on the actual cell for tensorial FE. More...
 
void fill_system_data (const FEInternalData &fe_data)
 Compute shape functions and gradients on the actual cell for mixed system of FE. More...
 
- Protected Attributes inherited from FEValuesBase< dim, spacedim >
Mapping< dim, spacedim > * mapping
 The mapping from the reference cell to the actual cell. More...
 
Quadrature< dim > * quadrature
 The quadrature rule used to calculate integrals. More...
 
FiniteElement< dim > * fe
 The used finite element. More...
 
MappingInternalDatamapping_data
 Precomputed mapping data. More...
 
FEInternalDatafe_data
 Precomputed finite element data. More...
 
FEValuesData< dim, spacedim > data
 Data computed by the mapping and finite element. More...
 
std::vector< std::shared_ptr< FEValuesBase< dim, spacedim > > > fe_values_vec
 Vector of FEValues for sub-elements of FESystem. More...
 
unsigned int n_components_
 Number of components of the FE. More...
 
ViewsCache views_cache_
 Auxiliary storage of FEValuesViews accessors. More...
 

Detailed Description

template<unsigned int dim, unsigned int spacedim>
class FEValues< dim, spacedim >

Calculates finite element data on the actual cell.

FEValues takes care of the calculation of finite element data on the actual cell such as values of shape functions at quadrature points, gradients of shape functions, Jacobians of the mapping from the reference cell etc.

Parameters
dimDimension of the reference cell.
spacedimDimension of the Euclidean space where the actual cell lives.

Definition at line 532 of file fe_values.hh.

Constructor & Destructor Documentation

template<unsigned int dim, unsigned int spacedim>
FEValues< dim, spacedim >::FEValues ( Mapping< dim, spacedim > &  _mapping,
Quadrature< dim > &  _quadrature,
FiniteElement< dim > &  _fe,
UpdateFlags  _flags 
)

Constructor.

Initializes structures and calculates cell-independent data.

Parameters
_mappingThe mapping between the reference and actual cell.
_quadratureThe quadrature rule.
_feThe finite element.
_flagsThe update flags.

Definition at line 502 of file fe_values.cc.

Member Function Documentation

template<unsigned int dim, unsigned int spacedim>
void FEValues< dim, spacedim >::reinit ( ElementAccessor< 3 > &  cell)

Update cell-dependent data (gradients, Jacobians etc.)

Parameters
cellThe actual cell.

Definition at line 528 of file fe_values.cc.

Here is the caller graph for this function:


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