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, fad_scalar_type val[], unsigned node_index[], double x[], double y[], double z[], fad_scalar_type res[]) const |
KOKKOS_INLINE_FUNCTION void | scatterResidual (const unsigned ielem, const unsigned node_index[], fad_scalar_type res[]) const |
template<typename local_scalar_type > | |
KOKKOS_INLINE_FUNCTION void | computeElementResidual (const local_scalar_type dof_values[], const double x[], const double y[], const double z[], local_scalar_type elem_res[]) 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 981 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 >, FadElement, CoeffFunctionType >::base_type |
Definition at line 990 of file FadMPAssembly/fenl_functors.hpp.
typedef base_type::scalar_type Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >::scalar_type |
Definition at line 992 of file FadMPAssembly/fenl_functors.hpp.
typedef base_type::execution_space Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >::execution_space |
Definition at line 993 of file FadMPAssembly/fenl_functors.hpp.
typedef Sacado::Fad::SLFad<scalar_type,FunctionCount> Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >::fad_scalar_type |
Definition at line 999 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 1005 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 1010 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 1025 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 1032 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 1053 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 1075 of file FadMPAssembly/fenl_functors.hpp.
|
inline |
Definition at line 1145 of file FadMPAssembly/fenl_functors.hpp.
|
static |
Definition at line 995 of file FadMPAssembly/fenl_functors.hpp.
|
static |
Definition at line 996 of file FadMPAssembly/fenl_functors.hpp.
|
static |
Definition at line 997 of file FadMPAssembly/fenl_functors.hpp.
const CoeffFunctionType Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >::coeff_function |
Definition at line 1002 of file FadMPAssembly/fenl_functors.hpp.
const Kokkos::Example::FENL::DeviceConfig Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >::dev_config |
Definition at line 1003 of file FadMPAssembly/fenl_functors.hpp.