Reference documentation for deal.II version GIT relicensing-487-ge9eb5ab491 2024-04-25 07:20:02+00:00
\(\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
Public Types | Public Member Functions | Static Public Attributes | Protected Member Functions | Protected Attributes | Static Protected Attributes | List of all members
FEPointEvaluationBase< n_components_, dim, spacedim, Number > Class Template Reference

#include <deal.II/matrix_free/fe_point_evaluation.h>

Inheritance diagram for FEPointEvaluationBase< n_components_, dim, spacedim, Number >:
Inheritance graph
[legend]

Public Types

using number_type = Number
 
using ScalarNumber = typename internal::VectorizedArrayTrait< Number >::value_type
 
using VectorizedArrayType = typename ::internal::VectorizedArrayTrait< Number >::vectorized_value_type
 
using ETT = typename internal::FEPointEvaluation::EvaluatorTypeTraits< dim, spacedim, n_components, Number >
 
using value_type = typename ETT::value_type
 
using scalar_value_type = typename ETT::scalar_value_type
 
using vectorized_value_type = typename ETT::vectorized_value_type
 
using gradient_type = typename ETT::real_gradient_type
 
using interface_vectorized_unit_gradient_type = typename ETT::interface_vectorized_unit_gradient_type
 

Public Member Functions

const value_typeget_value (const unsigned int point_index) const
 
void submit_value (const value_type &value, const unsigned int point_index)
 
const gradient_typeget_gradient (const unsigned int point_index) const
 
void submit_gradient (const gradient_type &, const unsigned int point_index)
 
DerivativeForm< 1, dim, spacedim, Number > jacobian (const unsigned int point_index) const
 
DerivativeForm< 1, spacedim, dim, Number > inverse_jacobian (const unsigned int point_index) const
 
Number JxW (const unsigned int point_index) const
 
Point< spacedim, Number > real_point (const unsigned int point_index) const
 
Point< spacedim, Number > quadrature_point (const unsigned int point_index) const
 
Point< dim, Number > unit_point (const unsigned int point_index) const
 
scalar_value_type integrate_value () const
 
std_cxx20::ranges::iota_view< unsigned int, unsigned intquadrature_point_indices () const
 
unsigned int n_active_entries_per_quadrature_batch (unsigned int q)
 

Static Public Attributes

static constexpr unsigned int dimension = dim
 
static constexpr unsigned int n_components = n_components_
 

Protected Member Functions

 FEPointEvaluationBase (const Mapping< dim, spacedim > &mapping, const FiniteElement< dim, spacedim > &fe, const UpdateFlags update_flags, const unsigned int first_selected_component=0)
 
 FEPointEvaluationBase (NonMatching::MappingInfo< dim, spacedim, Number > &mapping_info, const FiniteElement< dim, spacedim > &fe, const unsigned int first_selected_component=0, const bool is_interior=true)
 
 FEPointEvaluationBase (FEPointEvaluationBase &other) noexcept
 
 FEPointEvaluationBase (FEPointEvaluationBase &&other) noexcept
 
 ~FEPointEvaluationBase ()
 
void setup (const unsigned int first_selected_component)
 
template<bool is_face, bool is_linear>
void do_reinit ()
 

Protected Attributes

const unsigned int n_q_batches
 
const unsigned int n_q_points
 
const unsigned int n_q_points_scalar
 
SmartPointer< const Mapping< dim, spacedim > > mapping
 
SmartPointer< const FiniteElement< dim, spacedim > > fe
 
std::vector< Polynomials::Polynomial< double > > poly
 
bool use_linear_path
 
std::vector< unsigned intrenumber
 
std::vector< scalar_value_typesolution_renumbered
 
AlignedVector< vectorized_value_typesolution_renumbered_vectorized
 
AlignedVector< ScalarNumberscratch_data_scalar
 
std::vector< value_typevalues
 
std::vector< gradient_typegradients
 
const Point< dim, VectorizedArrayType > * unit_point_ptr
 
const Point< dim - 1, VectorizedArrayType > * unit_point_faces_ptr
 
const Point< spacedim, Number > * real_point_ptr
 
const DerivativeForm< 1, dim, spacedim, Number > * jacobian_ptr
 
const DerivativeForm< 1, spacedim, dim, Number > * inverse_jacobian_ptr
 
const Tensor< 1, spacedim, Number > * normal_ptr
 
const Number * JxW_ptr
 
internal::MatrixFreeFunctions::GeometryType cell_type
 
unsigned int dofs_per_component
 
unsigned int dofs_per_component_face
 
internal::MatrixFreeFunctions::ShapeInfo< ScalarNumbershape_info
 
unsigned int component_in_base_element
 
std::vector< std::array< bool, n_components > > nonzero_shape_function_component
 
const UpdateFlags update_flags
 
std::shared_ptr< FEValues< dim, spacedim > > fe_values
 
std::unique_ptr< NonMatching::MappingInfo< dim, spacedim, Number > > mapping_info_on_the_fly
 
SmartPointer< NonMatching::MappingInfo< dim, spacedim, Number > > mapping_info
 
unsigned int current_cell_index
 
unsigned int current_face_number
 
bool fast_path
 
boost::signals2::connection connection_is_reinitialized
 
bool is_reinitialized
 
AlignedVector<::ndarray< VectorizedArrayType, 2, dim > > shapes
 
AlignedVector<::ndarray< VectorizedArrayType, 2, dim - 1 > > shapes_faces
 
const bool is_interior
 

Static Protected Attributes

static constexpr std::size_t n_lanes_user_interface
 
static constexpr std::size_t n_lanes_internal
 
static constexpr std::size_t stride
 

Detailed Description

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
class FEPointEvaluationBase< n_components_, dim, spacedim, Number >

Base class of FEPointEvaluation and FEFacePointEvaluation. This class needs usually not be called in user code and does not have any public constructor. The usage is through the class FEPointEvaluation/FEFacePointEvaluation instead.

Definition at line 623 of file fe_point_evaluation.h.

Member Typedef Documentation

◆ number_type

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::number_type = Number

Definition at line 629 of file fe_point_evaluation.h.

◆ ScalarNumber

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::ScalarNumber = typename internal::VectorizedArrayTrait<Number>::value_type

Definition at line 631 of file fe_point_evaluation.h.

◆ VectorizedArrayType

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::VectorizedArrayType = typename ::internal::VectorizedArrayTrait< Number>::vectorized_value_type

Definition at line 633 of file fe_point_evaluation.h.

◆ ETT

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::ETT = typename internal::FEPointEvaluation:: EvaluatorTypeTraits<dim, spacedim, n_components, Number>

Definition at line 635 of file fe_point_evaluation.h.

◆ value_type

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::value_type = typename ETT::value_type

Definition at line 637 of file fe_point_evaluation.h.

◆ scalar_value_type

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::scalar_value_type = typename ETT::scalar_value_type

Definition at line 638 of file fe_point_evaluation.h.

◆ vectorized_value_type

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::vectorized_value_type = typename ETT::vectorized_value_type

Definition at line 639 of file fe_point_evaluation.h.

◆ gradient_type

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::gradient_type = typename ETT::real_gradient_type

Definition at line 640 of file fe_point_evaluation.h.

◆ interface_vectorized_unit_gradient_type

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
using FEPointEvaluationBase< n_components_, dim, spacedim, Number >::interface_vectorized_unit_gradient_type = typename ETT::interface_vectorized_unit_gradient_type

Definition at line 641 of file fe_point_evaluation.h.

Constructor & Destructor Documentation

◆ FEPointEvaluationBase() [1/4]

template<int n_components_, int dim, int spacedim, typename Number >
FEPointEvaluationBase< n_components_, dim, spacedim, Number >::FEPointEvaluationBase ( const Mapping< dim, spacedim > &  mapping,
const FiniteElement< dim, spacedim > &  fe,
const UpdateFlags  update_flags,
const unsigned int  first_selected_component = 0 
)
protected

Constructor.

Parameters
mappingThe Mapping class describing the actual geometry of a cell passed to the evaluate() function.
feThe FiniteElement object that is used for the evaluation, which is typically the same on all cells to be evaluated.
update_flagsSpecify the quantities to be computed by the mapping during the call of reinit(). During evaluate() or integrate(), this data is queried to produce the desired result (e.g., the gradient of a finite element solution).
first_selected_componentFor multi-component FiniteElement objects, this parameter allows to select a range of n_components components starting from this parameter.

Definition at line 1758 of file fe_point_evaluation.h.

◆ FEPointEvaluationBase() [2/4]

template<int n_components_, int dim, int spacedim, typename Number >
FEPointEvaluationBase< n_components_, dim, spacedim, Number >::FEPointEvaluationBase ( NonMatching::MappingInfo< dim, spacedim, Number > &  mapping_info,
const FiniteElement< dim, spacedim > &  fe,
const unsigned int  first_selected_component = 0,
const bool  is_interior = true 
)
protected

Constructor to make the present class able to re-use the geometry data also used by other FEPointEvaluationBase objects.

Parameters
mapping_infoThe MappingInfo class describes the geometry-related data for evaluating finite-element solutions. This object enables to construct such an object on the outside, possibly re-using it between several objects or between several calls to the same cell and unit points.
feThe FiniteElement object that is used for the evaluation, which is typically the same on all cells to be evaluated.
first_selected_componentFor multi-component FiniteElement objects, this parameter allows to select a range of n_components components starting from this parameter.
is_interiorDefines if interior or exterior. Only makes sense for faces.

Definition at line 1786 of file fe_point_evaluation.h.

◆ FEPointEvaluationBase() [3/4]

template<int n_components_, int dim, int spacedim, typename Number >
FEPointEvaluationBase< n_components_, dim, spacedim, Number >::FEPointEvaluationBase ( FEPointEvaluationBase< n_components_, dim, spacedim, Number > &  other)
protectednoexcept

Copy constructor.

Definition at line 1813 of file fe_point_evaluation.h.

◆ FEPointEvaluationBase() [4/4]

template<int n_components_, int dim, int spacedim, typename Number >
FEPointEvaluationBase< n_components_, dim, spacedim, Number >::FEPointEvaluationBase ( FEPointEvaluationBase< n_components_, dim, spacedim, Number > &&  other)
protectednoexcept

Move constructor.

Definition at line 1854 of file fe_point_evaluation.h.

◆ ~FEPointEvaluationBase()

template<int n_components_, int dim, int spacedim, typename Number >
FEPointEvaluationBase< n_components_, dim, spacedim, Number >::~FEPointEvaluationBase ( )
protected

Destructor.

Definition at line 1889 of file fe_point_evaluation.h.

Member Function Documentation

◆ get_value()

template<int n_components_, int dim, int spacedim, typename Number >
const FEPointEvaluationBase< n_components_, dim, spacedim, Number >::value_type & FEPointEvaluationBase< n_components_, dim, spacedim, Number >::get_value ( const unsigned int  point_index) const
inline

Return the value at quadrature point number point_index after a call to FEPointEvaluation::evaluate() with EvaluationFlags::values set, or the value that has been stored there with a call to FEPointEvaluationBase::submit_value(). If the object is vector-valued, a vector-valued return argument is given.

Definition at line 2120 of file fe_point_evaluation.h.

◆ submit_value()

template<int n_components_, int dim, int spacedim, typename Number >
void FEPointEvaluationBase< n_components_, dim, spacedim, Number >::submit_value ( const value_type value,
const unsigned int  point_index 
)
inline

Write a value to the field containing the values on points with component point_index. Access to the same field as through get_value(). If applied before the function FEPointEvaluation::integrate() with EvaluationFlags::values set is called, this specifies the value which is tested by all basis function on the current cell and integrated over.

Definition at line 2145 of file fe_point_evaluation.h.

◆ get_gradient()

template<int n_components_, int dim, int spacedim, typename Number >
const FEPointEvaluationBase< n_components_, dim, spacedim, Number >::gradient_type & FEPointEvaluationBase< n_components_, dim, spacedim, Number >::get_gradient ( const unsigned int  point_index) const
inline

Return the gradient in real coordinates at the point with index point_index after a call to FEPointEvaluation::evaluate() with EvaluationFlags::gradients set, or the gradient that has been stored there with a call to FEPointEvaluationBase::submit_gradient(). The gradient in real coordinates is obtained by taking the unit gradient (also accessible via get_unit_gradient()) and applying the inverse Jacobian of the mapping. If the object is vector-valued, a vector-valued return argument is given.

Definition at line 2134 of file fe_point_evaluation.h.

◆ submit_gradient()

template<int n_components_, int dim, int spacedim, typename Number >
void FEPointEvaluationBase< n_components_, dim, spacedim, Number >::submit_gradient ( const gradient_type gradient,
const unsigned int  point_index 
)
inline

Write a contribution that is tested by the gradient to the field containing the values on points with the given point_index. Access to the same field as through get_gradient(). If applied before the function FEPointEvaluation::integrate(EvaluationFlags::gradients) is called, this specifies what is tested by all basis function gradients on the current cell and integrated over.

Definition at line 2157 of file fe_point_evaluation.h.

◆ jacobian()

template<int n_components_, int dim, int spacedim, typename Number >
DerivativeForm< 1, dim, spacedim, Number > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::jacobian ( const unsigned int  point_index) const
inline

Return the Jacobian of the transformation on the current cell with the given point index. Prerequisite: This class needs to be constructed with UpdateFlags containing update_jacobian.

Definition at line 2169 of file fe_point_evaluation.h.

◆ inverse_jacobian()

template<int n_components_, int dim, int spacedim, typename Number >
DerivativeForm< 1, spacedim, dim, Number > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::inverse_jacobian ( const unsigned int  point_index) const
inline

Return the inverse of the Jacobian of the transformation on the current cell with the given point index. Prerequisite: This class needs to be constructed with UpdateFlags containing update_inverse_jacobian or update_gradients.

Definition at line 2187 of file fe_point_evaluation.h.

◆ JxW()

template<int n_components_, int dim, int spacedim, typename Number >
Number FEPointEvaluationBase< n_components_, dim, spacedim, Number >::JxW ( const unsigned int  point_index) const
inline

Return the Jacobian determinant multiplied by the quadrature weight. This class or the MappingInfo object passed to this function needs to be constructed with UpdateFlags containing update_JxW_values.

Definition at line 2206 of file fe_point_evaluation.h.

◆ real_point()

template<int n_components_, int dim, int spacedim, typename Number >
Point< spacedim, Number > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::real_point ( const unsigned int  point_index) const
inline

Return the position in real coordinates of the given point index among the points passed to reinit().

Deprecated:
Use the function quadrature_point() instead.

Definition at line 2221 of file fe_point_evaluation.h.

◆ quadrature_point()

template<int n_components_, int dim, int spacedim, typename Number >
Point< spacedim, Number > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::quadrature_point ( const unsigned int  point_index) const
inline

Return the position in real coordinates of the given point index among the points passed to reinit().

Definition at line 2232 of file fe_point_evaluation.h.

◆ unit_point()

template<int n_components_, int dim, int spacedim, typename Number >
Point< dim, Number > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::unit_point ( const unsigned int  point_index) const
inline

Return the position in unit/reference coordinates of the given point index, i.e., the respective point passed to the reinit() function.

Definition at line 2247 of file fe_point_evaluation.h.

◆ integrate_value()

template<int n_components_, int dim, int spacedim, typename Number >
FEPointEvaluationBase< n_components_, dim, spacedim, Number >::scalar_value_type FEPointEvaluationBase< n_components_, dim, spacedim, Number >::integrate_value ( ) const
inline

 * Take values collected at quadrature points via the submit_value() function, multiply by the Jacobian determinant and quadrature weights (JxW) and sum the values for all quadrature  * points on the cell. The result is a scalar, representing the integral  * of the function over the cell. 

Definition at line 2458 of file fe_point_evaluation.h.

◆ quadrature_point_indices()

template<int n_components_, int dim, int spacedim, typename Number >
std_cxx20::ranges::iota_view< unsigned int, unsigned int > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::quadrature_point_indices ( ) const
inline

Return an object that can be thought of as an array containing all indices from zero to n_quadrature_points. This allows to write code using range-based for loops.

Definition at line 2263 of file fe_point_evaluation.h.

◆ n_active_entries_per_quadrature_batch()

template<int n_components_, int dim, int spacedim, typename Number >
unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::n_active_entries_per_quadrature_batch ( unsigned int  q)

Returns how many lanes of a quadrature batch are active.

Definition at line 2473 of file fe_point_evaluation.h.

◆ setup()

template<int n_components_, int dim, int spacedim, typename Number >
void FEPointEvaluationBase< n_components_, dim, spacedim, Number >::setup ( const unsigned int  first_selected_component)
protected

Common setup function for both constructors. Does the setup for both fast and slow path.

Parameters
first_selected_componentFor multi-component FiniteElement objects, this parameter allows to select a range of n_components components starting from this parameter.

Definition at line 1899 of file fe_point_evaluation.h.

◆ do_reinit()

template<int n_components_, int dim, int spacedim, typename Number >
template<bool is_face, bool is_linear>
void FEPointEvaluationBase< n_components_, dim, spacedim, Number >::do_reinit ( )
inlineprotected

Shared functionality of all reinit() functions. Resizes data fields and precomputes the shapes vector, holding the evaluation of 1D basis functions of tensor product polynomials, if necessary.

Definition at line 1986 of file fe_point_evaluation.h.

Member Data Documentation

◆ dimension

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
constexpr unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::dimension = dim
staticconstexpr

Definition at line 626 of file fe_point_evaluation.h.

◆ n_components

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
constexpr unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::n_components = n_components_
staticconstexpr

Definition at line 627 of file fe_point_evaluation.h.

◆ n_lanes_user_interface

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
constexpr std::size_t FEPointEvaluationBase< n_components_, dim, spacedim, Number >::n_lanes_user_interface
staticconstexprprotected
Initial value:

Definition at line 826 of file fe_point_evaluation.h.

◆ n_lanes_internal

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
constexpr std::size_t FEPointEvaluationBase< n_components_, dim, spacedim, Number >::n_lanes_internal
staticconstexprprotected

◆ stride

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
constexpr std::size_t FEPointEvaluationBase< n_components_, dim, spacedim, Number >::stride
staticconstexprprotected
Initial value:

Definition at line 830 of file fe_point_evaluation.h.

◆ n_q_batches

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::n_q_batches
protected

Number of quadrature batches of the current cell/face.

Definition at line 856 of file fe_point_evaluation.h.

◆ n_q_points

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::n_q_points
protected

Number of quadrature points/batches of the current cell/face.

Definition at line 861 of file fe_point_evaluation.h.

◆ n_q_points_scalar

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::n_q_points_scalar
protected

Number of quadrature points of the current cell/face.

Definition at line 866 of file fe_point_evaluation.h.

◆ mapping

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
SmartPointer<const Mapping<dim, spacedim> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::mapping
protected

Pointer to the Mapping object passed to the constructor.

Definition at line 871 of file fe_point_evaluation.h.

◆ fe

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
SmartPointer<const FiniteElement<dim, spacedim> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::fe
protected

Pointer to the FiniteElement object passed to the constructor.

Definition at line 876 of file fe_point_evaluation.h.

◆ poly

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::vector<Polynomials::Polynomial<double> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::poly
protected

Description of the 1d polynomial basis for tensor product elements used for the fast path of this class using tensor product evaluators.

Definition at line 882 of file fe_point_evaluation.h.

◆ use_linear_path

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
bool FEPointEvaluationBase< n_components_, dim, spacedim, Number >::use_linear_path
protected

Store whether the linear path should be used.

Definition at line 887 of file fe_point_evaluation.h.

◆ renumber

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::vector<unsigned int> FEPointEvaluationBase< n_components_, dim, spacedim, Number >::renumber
protected

Renumbering between the unknowns of unknowns implied by the FiniteElement class and a lexicographic numbering used for the tensorized code path.

Definition at line 893 of file fe_point_evaluation.h.

◆ solution_renumbered

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::vector<scalar_value_type> FEPointEvaluationBase< n_components_, dim, spacedim, Number >::solution_renumbered
protected

Temporary array to store the solution_values passed to the evaluate() function in a format compatible with the tensor product evaluators. For vector-valued setups, this array uses a Tensor<1, n_components, ScalarNumber> type to collect the unknowns for a particular basis function.

Definition at line 902 of file fe_point_evaluation.h.

◆ solution_renumbered_vectorized

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
AlignedVector<vectorized_value_type> FEPointEvaluationBase< n_components_, dim, spacedim, Number >::solution_renumbered_vectorized
protected

Temporary array to store a vectorized version of the solution_values computed during integrate() in a format compatible with the tensor product evaluators. For vector-valued setups, this array uses a Tensor<1, n_components, VectorizedArrayType> format.

Definition at line 910 of file fe_point_evaluation.h.

◆ scratch_data_scalar

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
AlignedVector<ScalarNumber> FEPointEvaluationBase< n_components_, dim, spacedim, Number >::scratch_data_scalar
protected

Temporary array for the face path (scalar).

Definition at line 915 of file fe_point_evaluation.h.

◆ values

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::vector<value_type> FEPointEvaluationBase< n_components_, dim, spacedim, Number >::values
protected

Temporary array to store the values at the points.

Definition at line 920 of file fe_point_evaluation.h.

◆ gradients

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::vector<gradient_type> FEPointEvaluationBase< n_components_, dim, spacedim, Number >::gradients
protected

Temporary array to store the gradients in real coordinates at the points.

Definition at line 925 of file fe_point_evaluation.h.

◆ unit_point_ptr

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const Point<dim, VectorizedArrayType>* FEPointEvaluationBase< n_components_, dim, spacedim, Number >::unit_point_ptr
protected

Pointer to first unit point batch of current cell/face from MappingInfo, set internally during do_reinit().

Definition at line 931 of file fe_point_evaluation.h.

◆ unit_point_faces_ptr

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const Point<dim - 1, VectorizedArrayType>* FEPointEvaluationBase< n_components_, dim, spacedim, Number >::unit_point_faces_ptr
protected

Pointer to first unit point batch of current face from MappingInfo, set internally during do_reinit(). Needed for face path.

Definition at line 937 of file fe_point_evaluation.h.

◆ real_point_ptr

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const Point<spacedim, Number>* FEPointEvaluationBase< n_components_, dim, spacedim, Number >::real_point_ptr
protected

Pointer to real point of first quadrature point of current cell/face from MappingInfo, set internally during do_reinit().

Definition at line 943 of file fe_point_evaluation.h.

◆ jacobian_ptr

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const DerivativeForm<1, dim, spacedim, Number>* FEPointEvaluationBase< n_components_, dim, spacedim, Number >::jacobian_ptr
protected

Pointer to Jacobian of first quadrature point of current cell/face from MappingInfo, set internally during do_reinit().

Definition at line 949 of file fe_point_evaluation.h.

◆ inverse_jacobian_ptr

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const DerivativeForm<1, spacedim, dim, Number>* FEPointEvaluationBase< n_components_, dim, spacedim, Number >::inverse_jacobian_ptr
protected

Pointer to inverse Jacobian of first quadrature point of current cell/face from MappingInfo, set internally during do_reinit().

Definition at line 955 of file fe_point_evaluation.h.

◆ normal_ptr

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const Tensor<1, spacedim, Number>* FEPointEvaluationBase< n_components_, dim, spacedim, Number >::normal_ptr
protected

Pointer to normal vector of first quadrature point of current cell/face from MappingInfo, set internally during do_reinit().

Definition at line 961 of file fe_point_evaluation.h.

◆ JxW_ptr

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const Number* FEPointEvaluationBase< n_components_, dim, spacedim, Number >::JxW_ptr
protected

Pointer to Jacobian determinant times quadrature weight of first quadrature point of current cell/face from MappingInfo, set internally during do_reinit().

Definition at line 968 of file fe_point_evaluation.h.

◆ cell_type

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
internal::MatrixFreeFunctions::GeometryType FEPointEvaluationBase< n_components_, dim, spacedim, Number >::cell_type
protected

Cell type describing the geometry of the cell and compression of jacobians.

Definition at line 973 of file fe_point_evaluation.h.

◆ dofs_per_component

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::dofs_per_component
protected

Number of unknowns per component, i.e., number of unique basis functions, for the chosen FiniteElement (or base element).

Definition at line 979 of file fe_point_evaluation.h.

◆ dofs_per_component_face

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::dofs_per_component_face
protected

Number of unknowns per component, i.e., number of unique basis functions, for a restriction to the face of the chosen FiniteElement (or base element). This means a (dim-1)-dimensional basis.

Definition at line 986 of file fe_point_evaluation.h.

◆ shape_info

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
internal::MatrixFreeFunctions::ShapeInfo<ScalarNumber> FEPointEvaluationBase< n_components_, dim, spacedim, Number >::shape_info
protected

Scalar ShapeInfo object needed for face path.

Definition at line 991 of file fe_point_evaluation.h.

◆ component_in_base_element

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::component_in_base_element
protected

The first selected component in the active base element.

Definition at line 996 of file fe_point_evaluation.h.

◆ nonzero_shape_function_component

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::vector<std::array<bool, n_components> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::nonzero_shape_function_component
protected

For complicated FiniteElement objects this variable informs us about which unknowns actually carry degrees of freedom in the selected components.

Definition at line 1003 of file fe_point_evaluation.h.

◆ update_flags

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const UpdateFlags FEPointEvaluationBase< n_components_, dim, spacedim, Number >::update_flags
protected

The desired update flags for the evaluation.

Definition at line 1008 of file fe_point_evaluation.h.

◆ fe_values

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::shared_ptr<FEValues<dim, spacedim> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::fe_values
protected

The FEValues object underlying the slow evaluation path.

Definition at line 1013 of file fe_point_evaluation.h.

◆ mapping_info_on_the_fly

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
std::unique_ptr<NonMatching::MappingInfo<dim, spacedim, Number> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::mapping_info_on_the_fly
protected

Pointer to mapping info on the fly computed during reinit.

Definition at line 1019 of file fe_point_evaluation.h.

◆ mapping_info

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
SmartPointer<NonMatching::MappingInfo<dim, spacedim, Number> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::mapping_info
protected

Pointer to currently used mapping info (either on the fly or external precomputed).

Definition at line 1025 of file fe_point_evaluation.h.

◆ current_cell_index

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::current_cell_index
protected

The current cell index to access mapping data from mapping info.

Definition at line 1030 of file fe_point_evaluation.h.

◆ current_face_number

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
unsigned int FEPointEvaluationBase< n_components_, dim, spacedim, Number >::current_face_number
protected

The current face number to access mapping data from mapping info.

Definition at line 1035 of file fe_point_evaluation.h.

◆ fast_path

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
bool FEPointEvaluationBase< n_components_, dim, spacedim, Number >::fast_path
protected

Bool indicating if fast path is chosen.

Definition at line 1040 of file fe_point_evaluation.h.

◆ connection_is_reinitialized

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
boost::signals2::connection FEPointEvaluationBase< n_components_, dim, spacedim, Number >::connection_is_reinitialized
protected

Connection to NonMatching::MappingInfo to check whether mapping data has been invalidated.

Definition at line 1046 of file fe_point_evaluation.h.

◆ is_reinitialized

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
bool FEPointEvaluationBase< n_components_, dim, spacedim, Number >::is_reinitialized
protected

Bool indicating if class is reinitialized and data vectors a resized.

Definition at line 1051 of file fe_point_evaluation.h.

◆ shapes

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
AlignedVector<::ndarray<VectorizedArrayType, 2, dim> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::shapes
protected

Vector containing tensor product shape functions evaluated (during reinit()) at the vectorized unit points.

Definition at line 1057 of file fe_point_evaluation.h.

◆ shapes_faces

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
AlignedVector<::ndarray<VectorizedArrayType, 2, dim - 1> > FEPointEvaluationBase< n_components_, dim, spacedim, Number >::shapes_faces
protected

Vector containing tensor product shape functions evaluated (during reinit()) at the vectorized unit points on faces.

Definition at line 1063 of file fe_point_evaluation.h.

◆ is_interior

template<int n_components_, int dim, int spacedim = dim, typename Number = double>
const bool FEPointEvaluationBase< n_components_, dim, spacedim, Number >::is_interior
protected

Definition at line 1065 of file fe_point_evaluation.h.


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