Stokhos Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <fenl_functors.hpp>
Public Member Functions | |
ElementComputation (const ElementComputation &rhs) | |
ElementComputation (const typename base_type::mesh_type &arg_mesh, const CoeffFunctionType &arg_coeff_function, const typename base_type::vector_type &arg_solution, const typename base_type::elem_graph_type &arg_elem_graph, const typename base_type::sparse_matrix_type &arg_jacobian, const typename base_type::vector_type &arg_residual, const Kokkos::Example::FENL::DeviceConfig arg_dev_config) | |
void | apply () const |
KOKKOS_INLINE_FUNCTION void | gatherSolution (const unsigned ielem, scalar_type val[], unsigned node_index[], double x[], double y[], double z[], scalar_type res[], scalar_type mat[][FunctionCount]) const |
KOKKOS_INLINE_FUNCTION void | scatterResidual (const unsigned ielem, const unsigned node_index[], const scalar_type res[], const scalar_type mat[][FunctionCount]) const |
KOKKOS_INLINE_FUNCTION void | computeElementResidualJacobian (const scalar_type dof_values[], const double x[], const double y[], const double z[], scalar_type elem_res[], scalar_type elem_mat[][FunctionCount]) const |
KOKKOS_INLINE_FUNCTION void | operator() (const unsigned ielem) const |
![]() | |
ElementComputationBase (const ElementComputationBase &rhs) | |
ElementComputationBase (const mesh_type &arg_mesh, const vector_type &arg_solution, const elem_graph_type &arg_elem_graph, const sparse_matrix_type &arg_jacobian, const vector_type &arg_residual) | |
KOKKOS_INLINE_FUNCTION double | transform_gradients (const double grad[][FunctionCount], const double x[], const double y[], const double z[], double dpsidx[], double dpsidy[], double dpsidz[]) const |
Public Attributes | |
const CoeffFunctionType | coeff_function |
const Kokkos::Example::FENL::DeviceConfig | dev_config |
![]() | |
const element_data_type | elem_data |
const elem_node_type | elem_node_ids |
const node_coord_type | node_coords |
const elem_graph_type | elem_graph |
const elem_matrices_type | elem_jacobians |
const elem_vectors_type | elem_residuals |
const vector_type | solution |
const vector_type | residual |
const sparse_matrix_type | jacobian |
Static Public Attributes | |
static const unsigned | FunctionCount = base_type::FunctionCount |
static const unsigned | IntegrationCount = base_type::IntegrationCount |
static const unsigned | ElemNodeCount = base_type::ElemNodeCount |
![]() | |
static const unsigned | SpatialDim = element_data_type::spatial_dimension |
static const unsigned | TensorDim = SpatialDim * SpatialDim |
static const unsigned | ElemNodeCount = element_data_type::element_node_count |
static const unsigned | FunctionCount = element_data_type::function_count |
static const unsigned | IntegrationCount = element_data_type::integration_count |
Definition at line 769 of file FadMPAssembly/fenl_functors.hpp.
typedef ElementComputationBase<ExecutionSpace, Order, CoordinateMap, ScalarType> Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analytic, CoeffFunctionType >::base_type |
Definition at line 778 of file FadMPAssembly/fenl_functors.hpp.
typedef base_type::scalar_type Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analytic, CoeffFunctionType >::scalar_type |
Definition at line 780 of file FadMPAssembly/fenl_functors.hpp.
typedef base_type::execution_space Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analytic, CoeffFunctionType >::execution_space |
Definition at line 781 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 790 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 795 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 810 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 817 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 843 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 864 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 957 of file FadMPAssembly/fenl_functors.hpp.
|
static |
Definition at line 783 of file FadMPAssembly/fenl_functors.hpp.
|
static |
Definition at line 784 of file FadMPAssembly/fenl_functors.hpp.
|
static |
Definition at line 785 of file FadMPAssembly/fenl_functors.hpp.
const CoeffFunctionType Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analytic, CoeffFunctionType >::coeff_function |
Definition at line 787 of file FadMPAssembly/fenl_functors.hpp.
const Kokkos::Example::FENL::DeviceConfig Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analytic, CoeffFunctionType >::dev_config |
Definition at line 788 of file FadMPAssembly/fenl_functors.hpp.