33 template<
unsigned int dim,
unsigned int spacedim>
class FiniteElement;
34 template<
unsigned int dim,
unsigned int spacedim>
class FEValuesBase;
35 template<
unsigned int dim,
unsigned int spacedim>
class Mapping;
47 template<
unsigned int dim,
unsigned int spacedim>
136 template<
unsigned int spacedim>
148 virtual double shape_value(
const unsigned int function_no,
const unsigned int point_no) = 0;
157 virtual arma::vec::fixed<spacedim> shape_grad(
const unsigned int function_no,
const unsigned int point_no) = 0;
165 virtual double JxW(
const unsigned int point_no) = 0;
172 virtual arma::vec::fixed<spacedim> normal_vector(
unsigned int point_no) = 0;
177 virtual unsigned int n_dofs() = 0;
184 template<
unsigned int dim,
unsigned int spacedim>
239 double shape_value(
const unsigned int function_no,
const unsigned int point_no);
249 arma::vec::fixed<spacedim> shape_grad(
const unsigned int function_no,
const unsigned int point_no);
260 double shape_value_component(
const unsigned int function_no,
261 const unsigned int point_no,
262 const unsigned int comp)
const;
273 arma::vec::fixed<spacedim> shape_grad_component(
const unsigned int function_no,
274 const unsigned int point_no,
275 const unsigned int comp)
const;
288 return data.determinants[point_no];
297 inline double JxW(
const unsigned int point_no)
300 return data.JxW_values[point_no];
308 inline arma::vec::fixed<spacedim>
point(
const unsigned int point_no)
311 return data.points[point_no];
332 return data.normal_vectors[point_no];
342 return views_cache_.scalars[i];
352 return views_cache_.vectors[i];
360 return quadrature->size();
449 template<
unsigned int dim,
unsigned int spacedim>
494 template<
unsigned int dim,
unsigned int spacedim>
double JxW(const unsigned int point_no)
Return the product of Jacobian determinant and the quadrature weight at given quadrature point...
UpdateFlags
Enum type UpdateFlags indicates which quantities are to be recomputed on each finite element cell...
unsigned int n_dofs()
Returns the number of shape functions.
std::vector< arma::mat::fixed< dim, spacedim > > inverse_jacobians
Inverse Jacobians at the quadrature points.
MappingInternalData * mapping_data
Precomputed mapping data.
UpdateFlags update_flags
Flags that indicate which finite element quantities are to be computed.
FiniteElement< dim, spacedim > * get_fe() const
Returns the finite element in use.
FEValuesData< dim, spacedim > data
Data computed by the mapping and finite element.
std::vector< double > JxW_values
Transformed quadrature weights.
FEInternalData * fe_data
Precomputed finite element data.
unsigned int n_points()
Returns the number of quadrature points.
Enum type UpdateFlags indicates which quantities are to be recomputed on each finite element cell...
void allocate(unsigned int size, UpdateFlags flags, unsigned n_comp)
Resize the data arrays.
Base class for quadrature rules on simplices in arbitrary dimensions.
vector< FEValuesViews::Vector< dim, spacedim > > vectors
unsigned int n_components_
Number of components of the FE.
std::vector< arma::vec::fixed< spacedim > > normal_vectors
Shape functions (for vectorial finite elements) evaluated at quadrature points.
vector< FEValuesViews::Scalar< dim, spacedim > > scalars
arma::vec::fixed< spacedim > normal_vector(unsigned int point_no)
Returns the normal vector to a side at given quadrature point.
std::vector< arma::mat::fixed< spacedim, dim > > jacobians
Jacobians of the mapping at the quadrature points.
std::vector< arma::vec::fixed< spacedim > > points
Coordinates of quadrature points in the actual cell coordinate system.
Abstract class for the mapping between reference and actual cell.
FiniteElement< dim, spacedim > * fe
The used finite element.
virtual ~FEValuesSpaceBase()
ElementFullIter * present_cell
Iterator to the last reinit-ed cell.
const Quadrature< dim-1 > * sub_quadrature
Quadrature for the integration on the element sides.
const FEValuesViews::Vector< dim, spacedim > & vector_view(unsigned int i) const
Accessor to vector values of multicomponent FE.
Quadrature< dim > * quadrature
The quadrature rule used to calculate integrals.
Mapping< dim, spacedim > * get_mapping() const
Returns the mapping in use.
Class FEValuesData holds the arrays of data computed by Mapping and FiniteElement.
Quadrature< dim > * get_quadrature() const
Returns the quadrature in use.
ViewsCache views_cache_
Auxiliary storage of FEValuesViews accessors.
Mapping< dim, spacedim > * mapping
The mapping from the reference cell to the actual cell.
std::vector< std::vector< double > > shape_values
Shape functions evaluated at the quadrature points.
std::vector< double > determinants
Determinants of Jacobians at quadrature points.
Calculates finite element data on the actual cell.
vector< arma::vec::fixed< spacedim > > & point_list()
Return coordinates of all quadrature points in the actual cell system.
Class RefElement defines numbering of vertices, sides, calculation of normal vectors etc...
Structure for storing the precomputed finite element data.
Abstract class for the description of a general finite element on a reference simplex in dim dimensio...
Base class for FEValues and FESideValues.
Abstract base class with certain methods independent of the template parameter dim.
std::vector< std::vector< arma::vec::fixed< spacedim > > > shape_gradients
Gradients of shape functions evaluated at the quadrature points.
Mapping data that can be precomputed on the actual cell.
const FEValuesViews::Scalar< dim, spacedim > & scalar_view(unsigned int i) const
Accessor to scalar values of multicomponent FE.
double determinant(const unsigned int point_no)
Return the relative volume change of the cell (Jacobian determinant).
Calculates finite element data on a side.
#define ASSERT_LT_DBG(a, b)
Definition of comparative assert macro (Less Than) only for debug mode.
arma::vec::fixed< spacedim > point(const unsigned int point_no)
Return coordinates of the quadrature point in the actual cell system.