Reference documentation for deal.II version 9.2.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\}}\)
Static Public Member Functions | List of all members
internal::FEEvaluationImplTransformToCollocation< dim, fe_degree, n_q_points_1d, n_components, Number > Struct Template Reference

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

Static Public Member Functions

static void evaluate (const MatrixFreeFunctions::ShapeInfo< Number > &shape_info, const Number *values_dofs, Number *values_quad, Number *gradients_quad, Number *hessians_quad, Number *scratch_data, const bool evaluate_values, const bool evaluate_gradients, const bool evaluate_hessians)
 
static void integrate (const MatrixFreeFunctions::ShapeInfo< Number > &shape_info, Number *values_dofs, Number *values_quad, Number *gradients_quad, Number *scratch_data, const bool integrate_values, const bool integrate_gradients, const bool add_into_values_array)
 

Detailed Description

template<int dim, int fe_degree, int n_q_points_1d, int n_components, typename Number>
struct internal::FEEvaluationImplTransformToCollocation< dim, fe_degree, n_q_points_1d, n_components, Number >

This struct performs the evaluation of function values, gradients and Hessians for tensor-product finite elements. This a specialization for symmetric basis functions about the mid point 0.5 of the unit interval with the same number of quadrature points as degrees of freedom. In that case, we can first transform the basis to one that has the nodal points in the quadrature points (i.e., the collocation space) and then perform the evaluation of the first and second derivatives in this transformed space, using the identity operation for the shape values.

Author
Katharina Kormann, Martin Kronbichler, 2017

Definition at line 1194 of file evaluation_kernels.h.

Member Function Documentation

◆ evaluate()

template<int dim, int fe_degree, int n_q_points_1d, int n_components, typename Number >
void internal::FEEvaluationImplTransformToCollocation< dim, fe_degree, n_q_points_1d, n_components, Number >::evaluate ( const MatrixFreeFunctions::ShapeInfo< Number > &  shape_info,
const Number *  values_dofs,
Number *  values_quad,
Number *  gradients_quad,
Number *  hessians_quad,
Number *  scratch_data,
const bool  evaluate_values,
const bool  evaluate_gradients,
const bool  evaluate_hessians 
)
inlinestatic

Definition at line 1231 of file evaluation_kernels.h.

◆ integrate()

template<int dim, int fe_degree, int n_q_points_1d, int n_components, typename Number >
void internal::FEEvaluationImplTransformToCollocation< dim, fe_degree, n_q_points_1d, n_components, Number >::integrate ( const MatrixFreeFunctions::ShapeInfo< Number > &  shape_info,
Number *  values_dofs,
Number *  values_quad,
Number *  gradients_quad,
Number *  scratch_data,
const bool  integrate_values,
const bool  integrate_gradients,
const bool  add_into_values_array 
)
inlinestatic

Definition at line 1294 of file evaluation_kernels.h.


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