if ((evaluate_flag & EvaluationFlags::values) &&
(evaluate_flag & EvaluationFlags::gradients))
{
- evaluator_tensor_product.value_and_gradient_at_quad_pts(
+ evaluator_tensor_product.evaluate_values_and_gradients(
shared_data->values, shared_data->gradients);
shared_data->team_member.team_barrier();
}
else if (evaluate_flag & EvaluationFlags::gradients)
{
- evaluator_tensor_product.gradient_at_quad_pts(shared_data->values,
- shared_data->gradients);
+ evaluator_tensor_product.evaluate_gradients(shared_data->values,
+ shared_data->gradients);
shared_data->team_member.team_barrier();
}
else if (evaluate_flag & EvaluationFlags::values)
{
- evaluator_tensor_product.value_at_quad_pts(shared_data->values);
+ evaluator_tensor_product.evaluate_values(shared_data->values);
shared_data->team_member.team_barrier();
}
}
if ((integration_flag & EvaluationFlags::values) &&
(integration_flag & EvaluationFlags::gradients))
{
- evaluator_tensor_product.integrate_value_and_gradient(
+ evaluator_tensor_product.integrate_values_and_gradients(
shared_data->values, shared_data->gradients);
}
else if (integration_flag & EvaluationFlags::values)
{
- evaluator_tensor_product.integrate_value(shared_data->values);
+ evaluator_tensor_product.integrate_values(shared_data->values);
shared_data->team_member.team_barrier();
}
else if (integration_flag & EvaluationFlags::gradients)
{
- evaluator_tensor_product.template integrate_gradient<false>(
+ evaluator_tensor_product.template integrate_gradients<false>(
shared_data->values, shared_data->gradients);
shared_data->team_member.team_barrier();
}
n_q_points_1d,
Number>
{
+ public:
using TeamHandle = Kokkos::TeamPolicy<
MemorySpace::Default::kokkos_space::execution_space>::member_type;
co_shape_gradients);
/**
- * Evaluate the values of a finite element function at the quadrature
- * points.
+ * Evaluate the finite element function at the quadrature points.
*/
- template <int direction,
- bool dof_to_quad,
- bool add,
- bool in_place,
- typename ViewTypeIn,
- typename ViewTypeOut>
+ template <typename ViewType>
DEAL_II_HOST_DEVICE void
- values(const ViewTypeIn in, ViewTypeOut out) const;
+ evaluate_values(ViewType u);
/**
- * Evaluate the gradient of a finite element function at the quadrature
- * points for a given @p direction.
+ * Evaluate the gradients of the finite element function at the quadrature
+ * points.
*/
- template <int direction,
- bool dof_to_quad,
- bool add,
- bool in_place,
- typename ViewTypeIn,
- typename ViewTypeOut>
+ template <typename ViewTypeIn, typename ViewTypeOut>
DEAL_II_HOST_DEVICE void
- gradients(const ViewTypeIn in, ViewTypeOut out) const;
+ evaluate_gradients(const ViewTypeIn u, ViewTypeOut grad_u);
/**
- * Evaluate the gradient of a finite element function at the quadrature
- * points for a given @p direction for collocation methods.
+ * Evaluate the values and the gradients of the finite element function at
+ * the quadrature points.
*/
- template <int direction,
- bool dof_to_quad,
- bool add,
- bool in_place,
- typename ViewTypeIn,
- typename ViewTypeOut>
+ template <typename ViewType1, typename ViewType2>
DEAL_II_HOST_DEVICE void
- co_gradients(const ViewTypeIn in, ViewTypeOut out) const;
+ evaluate_values_and_gradients(ViewType1 u, ViewType2 grad_u);
/**
- * Evaluate the finite element function at the quadrature points.
+ * Helper function for integrate(). Integrate the finite element function.
*/
template <typename ViewType>
DEAL_II_HOST_DEVICE void
- value_at_quad_pts(ViewType u);
+ integrate_values(ViewType u);
/**
- * Helper function for integrate(). Integrate the finite element function.
+ * Helper function for integrate(). Integrate the gradients of the finite
+ * element function.
*/
- template <typename ViewType>
+ template <bool add, typename ViewType1, typename ViewType2>
DEAL_II_HOST_DEVICE void
- integrate_value(ViewType u);
+ integrate_gradients(ViewType1 u, ViewType2 grad_u);
/**
- * Evaluate the gradients of the finite element function at the quadrature
- * points.
+ * Helper function for integrate(). Integrate the values and the gradients
+ * of the finite element function.
*/
- template <typename ViewTypeIn, typename ViewTypeOut>
+ template <typename ViewType1, typename ViewType2>
DEAL_II_HOST_DEVICE void
- gradient_at_quad_pts(const ViewTypeIn u, ViewTypeOut grad_u);
+ integrate_values_and_gradients(ViewType1 u, ViewType2 grad_u);
/**
- * Evaluate the values and the gradients of the finite element function at
- * the quadrature points.
+ * Evaluate/integrate the values of a finite element function at the
+ * quadrature points for a given @p direction.
*/
- template <typename ViewType1, typename ViewType2>
+ template <int direction,
+ bool dof_to_quad,
+ bool add,
+ bool in_place,
+ typename ViewTypeIn,
+ typename ViewTypeOut>
DEAL_II_HOST_DEVICE void
- value_and_gradient_at_quad_pts(ViewType1 u, ViewType2 grad_u);
+ values(const ViewTypeIn in, ViewTypeOut out) const;
/**
- * Helper function for integrate(). Integrate the gradients of the finite
- * element function.
+ * Evaluate/integrate the gradient of a finite element function at the
+ * quadrature points for a given @p direction.
*/
- template <bool add, typename ViewType1, typename ViewType2>
+ template <int direction,
+ bool dof_to_quad,
+ bool add,
+ bool in_place,
+ typename ViewTypeIn,
+ typename ViewTypeOut>
DEAL_II_HOST_DEVICE void
- integrate_gradient(ViewType1 u, ViewType2 grad_u);
+ gradients(const ViewTypeIn in, ViewTypeOut out) const;
+ public:
/**
- * Helper function for integrate(). Integrate the values and the gradients
- * of the finite element function.
+ * Evaluate the gradient of a finite element function at the quadrature
+ * points for a given @p direction for collocation methods.
*/
- template <typename ViewType1, typename ViewType2>
+ template <int direction,
+ bool dof_to_quad,
+ bool add,
+ bool in_place,
+ typename ViewTypeIn,
+ typename ViewTypeOut>
DEAL_II_HOST_DEVICE void
- integrate_value_and_gradient(ViewType1 u, ViewType2 grad_u);
+ co_gradients(const ViewTypeIn in, ViewTypeOut out) const;
/**
* TeamPolicy handle.
dim,
fe_degree,
n_q_points_1d,
- Number>::value_at_quad_pts(ViewType u)
+ Number>::evaluate_values(ViewType u)
{
if constexpr (dim == 1)
values<0, true, false, true>(u, u);
dim,
fe_degree,
n_q_points_1d,
- Number>::integrate_value(ViewType u)
+ Number>::integrate_values(ViewType u)
{
if constexpr (dim == 1)
values<0, false, false, true>(u, u);
dim,
fe_degree,
n_q_points_1d,
- Number>::gradient_at_quad_pts(const ViewTypeIn u,
- ViewTypeOut grad_u)
+ Number>::evaluate_gradients(const ViewTypeIn u,
+ ViewTypeOut grad_u)
{
if constexpr (dim == 1)
{
dim,
fe_degree,
n_q_points_1d,
- Number>::value_and_gradient_at_quad_pts(ViewType1 u,
- ViewType2
- grad_u)
+ Number>::evaluate_values_and_gradients(ViewType1 u,
+ ViewType2
+ grad_u)
{
if constexpr (dim == 1)
{
dim,
fe_degree,
n_q_points_1d,
- Number>::integrate_gradient(ViewType1 u,
- ViewType2 grad_u)
+ Number>::integrate_gradients(ViewType1 u,
+ ViewType2 grad_u)
{
if constexpr (dim == 1)
{
dim,
fe_degree,
n_q_points_1d,
- Number>::integrate_value_and_gradient(ViewType1 u,
- ViewType2
- grad_u)
+ Number>::integrate_values_and_gradients(ViewType1 u,
+ ViewType2
+ grad_u)
{
if constexpr (dim == 1)
{