|
| FEEvaluationAccess (const MatrixFree< dim, Number > &matrix_free, const unsigned int dof_no, const unsigned int first_selected_component, const unsigned int quad_no, const unsigned int fe_degree, const unsigned int n_q_points, const bool is_interior_face=true) |
|
template<int n_components_other> |
| FEEvaluationAccess (const Mapping< dim > &mapping, const FiniteElement< dim > &fe, const Quadrature< 1 > &quadrature, const UpdateFlags update_flags, const unsigned int first_selected_component, const FEEvaluationBase< dim, n_components_other, Number, is_face > *other) |
|
| FEEvaluationAccess (const FEEvaluationAccess &other) |
|
FEEvaluationAccess & | operator= (const FEEvaluationAccess &other) |
|
| FEEvaluationBase (const MatrixFree< dim, Number > &matrix_free, const unsigned int dof_no, const unsigned int first_selected_component, const unsigned int quad_no, const unsigned int fe_degree, const unsigned int n_q_points, const bool is_interior_face) |
|
template<int n_components_other> |
| FEEvaluationBase (const Mapping< dim > &mapping, const FiniteElement< dim > &fe, const Quadrature< 1 > &quadrature, const UpdateFlags update_flags, const unsigned int first_selected_component, const FEEvaluationBase< dim, n_components_other, Number > *other) |
|
| FEEvaluationBase (const FEEvaluationBase &other) |
|
FEEvaluationBase & | operator= (const FEEvaluationBase &other) |
|
template<typename VectorType , typename VectorOperation > |
void | read_write_operation (const VectorOperation &operation, VectorType *vectors[], const std::bitset< VectorizedArray< Number >::n_array_elements > &mask, const bool apply_constraints=true) const |
|
template<typename VectorType , typename VectorOperation > |
void | read_write_operation_contiguous (const VectorOperation &operation, VectorType *vectors[], const std::bitset< VectorizedArray< Number >::n_array_elements > &mask) const |
|
template<typename VectorType , typename VectorOperation > |
void | read_write_operation_global (const VectorOperation &operation, VectorType *vectors[]) const |
|
|
| ~FEEvaluationBase () |
|
unsigned int | get_cell_data_number () const |
|
unsigned int | get_mapping_data_index_offset () const |
|
internal::MatrixFreeFunctions::GeometryType | get_cell_type () const |
|
const internal::MatrixFreeFunctions::ShapeInfo< VectorizedArray< Number > > & | get_shape_info () const |
|
template<typename VectorType > |
void | read_dof_values (const VectorType &src, const unsigned int first_index=0) |
|
template<typename VectorType > |
void | read_dof_values_plain (const VectorType &src, const unsigned int first_index=0) |
|
template<typename VectorType > |
void | distribute_local_to_global (VectorType &dst, const unsigned int first_index=0, const std::bitset< VectorizedArray< Number >::n_array_elements > &mask=std::bitset< VectorizedArray< Number >::n_array_elements >().flip()) const |
|
template<typename VectorType > |
void | set_dof_values (VectorType &dst, const unsigned int first_index=0, const std::bitset< VectorizedArray< Number >::n_array_elements > &mask=std::bitset< VectorizedArray< Number >::n_array_elements >().flip()) const |
|
value_type | get_dof_value (const unsigned int dof) const |
|
void | submit_dof_value (const value_type val_in, const unsigned int dof) |
|
value_type | get_value (const unsigned int q_point) const |
|
void | submit_value (const value_type val_in, const unsigned int q_point) |
|
gradient_type | get_gradient (const unsigned int q_point) const |
|
value_type | get_normal_derivative (const unsigned int q_point) const |
|
void | submit_gradient (const gradient_type grad_in, const unsigned int q_point) |
|
void | submit_normal_derivative (const value_type grad_in, const unsigned int q_point) |
|
Tensor< 1, n_components_, Tensor< 2, dim, VectorizedArray< Number > > > | get_hessian (const unsigned int q_point) const |
|
gradient_type | get_hessian_diagonal (const unsigned int q_point) const |
|
value_type | get_laplacian (const unsigned int q_point) const |
|
VectorizedArray< Number > | get_divergence (const unsigned int q_point) const |
|
SymmetricTensor< 2, dim, VectorizedArray< Number > > | get_symmetric_gradient (const unsigned int q_point) const |
|
Tensor< 1,(dim==2 ? 1 :dim), VectorizedArray< Number > > | get_curl (const unsigned int q_point) const |
|
void | submit_divergence (const VectorizedArray< Number > div_in, const unsigned int q_point) |
|
void | submit_symmetric_gradient (const SymmetricTensor< 2, dim, VectorizedArray< Number >> grad_in, const unsigned int q_point) |
|
void | submit_curl (const Tensor< 1, dim==2 ? 1 :dim, VectorizedArray< Number >> curl_in, const unsigned int q_point) |
|
value_type | integrate_value () const |
|
VectorizedArray< Number > | JxW (const unsigned int q_index) const |
|
void | fill_JxW_values (AlignedVector< VectorizedArray< Number >> &JxW_values) const |
|
Tensor< 2, dim, VectorizedArray< Number > > | inverse_jacobian (const unsigned int q_index) const |
|
Tensor< 1, dim, VectorizedArray< Number > > | get_normal_vector (const unsigned int q_point) const |
|
VectorizedArray< Number > | read_cell_data (const AlignedVector< VectorizedArray< Number >> &array) const |
|
const VectorizedArray< Number > * | begin_dof_values () const |
|
VectorizedArray< Number > * | begin_dof_values () |
|
const VectorizedArray< Number > * | begin_values () const |
|
VectorizedArray< Number > * | begin_values () |
|
const VectorizedArray< Number > * | begin_gradients () const |
|
VectorizedArray< Number > * | begin_gradients () |
|
const VectorizedArray< Number > * | begin_hessians () const |
|
VectorizedArray< Number > * | begin_hessians () |
|
const std::vector< unsigned int > & | get_internal_dof_numbering () const |
|
ArrayView< VectorizedArray< Number > > | get_scratch_data () const |
|
AlignedVector< VectorizedArray< Number > > * | scratch_data_array |
|
VectorizedArray< Number > * | scratch_data |
|
VectorizedArray< Number > * | values_dofs [n_components] |
|
VectorizedArray< Number > * | values_quad [n_components] |
|
VectorizedArray< Number > * | gradients_quad [n_components][dim] |
|
VectorizedArray< Number > * | hessians_quad [n_components][(dim *(dim+1))/2] |
|
const unsigned int | quad_no |
|
const unsigned int | n_fe_components |
|
const unsigned int | active_fe_index |
|
const unsigned int | active_quad_index |
|
const unsigned int | n_quadrature_points |
|
const MatrixFree< dim, Number > * | matrix_info |
|
const internal::MatrixFreeFunctions::DoFInfo * | dof_info |
|
const internal::MatrixFreeFunctions::MappingInfoStorage<(is_face ? dim - 1 :dim), dim, Number > * | mapping_data |
|
const internal::MatrixFreeFunctions::ShapeInfo< VectorizedArray< Number > > * | data |
|
const Tensor< 2, dim, VectorizedArray< Number > > * | jacobian |
|
const VectorizedArray< Number > * | J_value |
|
const Tensor< 1, dim, VectorizedArray< Number > > * | normal_vectors |
|
const Tensor< 1, dim, VectorizedArray< Number > > * | normal_x_jacobian |
|
const Number * | quadrature_weights |
|
unsigned int | cell |
|
bool | is_interior_face |
|
internal::MatrixFreeFunctions::DoFInfo::DoFAccessIndex | dof_access_index |
|
unsigned int | face_no |
|
unsigned int | face_orientation |
|
unsigned int | subface_index |
|
internal::MatrixFreeFunctions::GeometryType | cell_type |
|
bool | dof_values_initialized |
|
bool | values_quad_initialized |
|
bool | gradients_quad_initialized |
|
bool | hessians_quad_initialized |
|
bool | values_quad_submitted |
|
bool | gradients_quad_submitted |
|
std::shared_ptr< internal::MatrixFreeFunctions::MappingDataOnTheFly< dim, Number > > | mapped_geometry |
|
const unsigned int | first_selected_component |
|
std::vector< types::global_dof_index > | local_dof_indices |
|
template<int dim, int n_components_, typename Number, bool is_face>
class FEEvaluationAccess< dim, n_components_, Number, is_face >
This class provides access to the data fields of the FEEvaluation classes. Generic access is achieved through the base class, and specializations for scalar and vector-valued elements are defined separately.
- Author
- Katharina Kormann and Martin Kronbichler, 2010, 2011
Definition at line 1127 of file fe_evaluation.h.