Loading [MathJax]/extensions/TeX/newcommand.js
 deal.II version GIT relicensing-2848-g5241f990fb 2025-03-16 19:30:00+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\}}
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Modules Pages Concepts
Static Public Member Functions | List of all members
Portable::internal::FEEvaluationImplTransformToCollocation< dim, fe_degree, n_q_points_1d, Number > Struct Template Reference

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

Static Public Member Functions

static void evaluate (const unsigned int n_components, const EvaluationFlags::EvaluationFlags evaluation_flag, const typename MatrixFree< dim, Number >::Data *data, SharedData< dim, Number > *shared_data)
 
static void integrate (const unsigned int n_components, const EvaluationFlags::EvaluationFlags integration_flag, const typename MatrixFree< dim, Number >::Data *data, const SharedData< dim, Number > *shared_data)
 

Detailed Description

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

This struct performs the evaluation of function values and gradients for tensor-product finite elements. This is 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.

Definition at line 482 of file portable_evaluation_kernels.h.

Member Function Documentation

◆ evaluate()

template<int dim, int fe_degree, int n_q_points_1d, typename Number >
static void Portable::internal::FEEvaluationImplTransformToCollocation< dim, fe_degree, n_q_points_1d, Number >::evaluate ( const unsigned int  n_components,
const EvaluationFlags::EvaluationFlags  evaluation_flag,
const typename MatrixFree< dim, Number >::Data *  data,
SharedData< dim, Number > *  shared_data 
)
inlinestatic

Definition at line 485 of file portable_evaluation_kernels.h.

◆ integrate()

template<int dim, int fe_degree, int n_q_points_1d, typename Number >
static void Portable::internal::FEEvaluationImplTransformToCollocation< dim, fe_degree, n_q_points_1d, Number >::integrate ( const unsigned int  n_components,
const EvaluationFlags::EvaluationFlags  integration_flag,
const typename MatrixFree< dim, Number >::Data *  data,
const SharedData< dim, Number > *  shared_data 
)
inlinestatic

Definition at line 536 of file portable_evaluation_kernels.h.


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