![]() |
deal.II version GIT relicensing-3139-g1f7709904a 2025-04-24 22:10:00+00:00
|
#include <deal.II/matrix_free/portable_evaluation_kernels.h>
Public Types | |
using | TeamHandle = Kokkos::TeamPolicy< MemorySpace::Default::kokkos_space::execution_space >::member_type |
using | SharedView = Kokkos::View< Number *, MemorySpace::Default::kokkos_space::execution_space::scratch_memory_space, Kokkos::MemoryTraits< Kokkos::Unmanaged > > |
Static Public Member Functions | |
static void | evaluate (const unsigned int n_components, const EvaluationFlags::EvaluationFlags evaluation_flag, const typename MatrixFree< dim, Number >::Data *data) |
static void | integrate (const unsigned int n_components, const EvaluationFlags::EvaluationFlags integration_flag, const typename MatrixFree< dim, Number >::Data *data) |
This struct performs the evaluation of function values and gradients for tensor-product finite elements. There are two specialized implementation classes FEEvaluationImplCollocation (for Gauss-Lobatto elements where the nodal points and the quadrature points coincide and the 'values' operation is identity) and FEEvaluationImplTransformToCollocation (which can be transformed to a collocation space and can then use the identity in these spaces), which both allow for shorter code.
Definition at line 65 of file portable_evaluation_kernels.h.
using Portable::internal::FEEvaluationImpl< dim, fe_degree, n_q_points_1d, Number >::TeamHandle = Kokkos::TeamPolicy< MemorySpace::Default::kokkos_space::execution_space>::member_type |
Definition at line 67 of file portable_evaluation_kernels.h.
using Portable::internal::FEEvaluationImpl< dim, fe_degree, n_q_points_1d, Number >::SharedView = Kokkos::View<Number *, MemorySpace::Default::kokkos_space:: execution_space::scratch_memory_space, Kokkos::MemoryTraits<Kokkos::Unmanaged> > |
Definition at line 69 of file portable_evaluation_kernels.h.
|
inlinestatic |
Definition at line 75 of file portable_evaluation_kernels.h.
|
inlinestatic |
Definition at line 200 of file portable_evaluation_kernels.h.