Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
Public Types | Public Member Functions | Static Public Attributes | List of all members
Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType > Class Template Reference

#include <fenl_functors.hpp>

Inheritance diagram for Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >:
Inheritance graph
[legend]

Public Types

typedef ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType > base_type
 
typedef base_type::scalar_type scalar_type
 
typedef base_type::execution_space execution_space
 
typedef Sacado::Fad::SLFad< scalar_type, FunctionCountfad_scalar_type
 
- Public Types inherited from Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >
typedef ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType > base_type
 
typedef base_type::scalar_type scalar_type
 
typedef base_type::execution_space execution_space
 
typedef Sacado::Fad::SLFad< scalar_type, FunctionCountfad_scalar_type
 
- Public Types inherited from Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >
typedef Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap > mesh_type
 
typedef Kokkos::Example::HexElement_Data< mesh_type::ElemNodeelement_data_type
 
typedef ExecutionSpace execution_space
 
typedef ScalarType scalar_type
 
typedef CrsMatrix< ScalarType, ExecutionSpace > sparse_matrix_type
 
typedef sparse_matrix_type::StaticCrsGraphType sparse_graph_type
 
typedef Kokkos::View< scalar_type *, Kokkos::LayoutLeft, execution_spacevector_type
 
typedef mesh_type::node_coord_type node_coord_type
 
typedef mesh_type::elem_node_type elem_node_type
 
typedef Kokkos::View< scalar_type *[FunctionCount][FunctionCount], execution_spaceelem_matrices_type
 
typedef Kokkos::View< scalar_type *[FunctionCount], execution_spaceelem_vectors_type
 
typedef NodeNodeGraph< elem_node_type, sparse_graph_type, ElemNodeCount >::ElemGraphType elem_graph_type
 

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[], fad_scalar_type res[]) const
 
template<typename local_scalar_type >
KOKKOS_INLINE_FUNCTION void computeElementResidual (const 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
 
- Public Member Functions inherited from Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >
 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
 
- Public Member Functions inherited from Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >
 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
 

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 Public Attributes inherited from Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >
static const unsigned FunctionCount = base_type::FunctionCount
 
static const unsigned IntegrationCount = base_type::IntegrationCount
 
static const unsigned ElemNodeCount = base_type::ElemNodeCount
 
- Static Public Attributes inherited from Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >
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
 

Additional Inherited Members

- Public Attributes inherited from Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement, CoeffFunctionType >
const CoeffFunctionType coeff_function
 
const Kokkos::Example::FENL::DeviceConfig dev_config
 
- Public Attributes inherited from Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >
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
 

Detailed Description

template<class ExecutionSpace, BoxElemPart::ElemOrder Order, class CoordinateMap, typename ScalarType, class CoeffFunctionType>
class Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >

Definition at line 1172 of file FadMPAssembly/fenl_functors.hpp.

Member Typedef Documentation

◆ base_type

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
typedef ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace , Order , CoordinateMap > , CrsMatrix< ScalarType , ExecutionSpace > , FadElement , CoeffFunctionType > Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::base_type

Definition at line 1183 of file FadMPAssembly/fenl_functors.hpp.

◆ scalar_type

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
typedef base_type::scalar_type Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::scalar_type

Definition at line 1185 of file FadMPAssembly/fenl_functors.hpp.

◆ execution_space

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
typedef base_type::execution_space Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::execution_space

Definition at line 1186 of file FadMPAssembly/fenl_functors.hpp.

◆ fad_scalar_type

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
typedef Sacado::Fad::SLFad<scalar_type,FunctionCount> Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::fad_scalar_type

Definition at line 1192 of file FadMPAssembly/fenl_functors.hpp.

Constructor & Destructor Documentation

◆ ElementComputation() [1/2]

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::ElementComputation ( const ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType > &  rhs)
inline

Definition at line 1195 of file FadMPAssembly/fenl_functors.hpp.

◆ ElementComputation() [2/2]

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::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 
)
inline

Definition at line 1197 of file FadMPAssembly/fenl_functors.hpp.

Member Function Documentation

◆ apply()

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
void Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::apply ( ) const
inline

Definition at line 1210 of file FadMPAssembly/fenl_functors.hpp.

◆ gatherSolution()

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
KOKKOS_INLINE_FUNCTION void Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::gatherSolution ( const unsigned  ielem,
scalar_type  val[],
unsigned  node_index[],
double  x[],
double  y[],
double  z[],
fad_scalar_type  res[] 
) const
inline

Definition at line 1217 of file FadMPAssembly/fenl_functors.hpp.

◆ computeElementResidual()

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
template<typename local_scalar_type >
KOKKOS_INLINE_FUNCTION void Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::computeElementResidual ( const scalar_type  dof_values[],
const double  x[],
const double  y[],
const double  z[],
local_scalar_type  elem_res[] 
) const
inline

Definition at line 1238 of file FadMPAssembly/fenl_functors.hpp.

◆ operator()()

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
KOKKOS_INLINE_FUNCTION void Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::operator() ( const unsigned  ielem) const
inline

Definition at line 1315 of file FadMPAssembly/fenl_functors.hpp.

Member Data Documentation

◆ FunctionCount

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
const unsigned Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::FunctionCount = base_type::FunctionCount
static

Definition at line 1188 of file FadMPAssembly/fenl_functors.hpp.

◆ IntegrationCount

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
const unsigned Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::IntegrationCount = base_type::IntegrationCount
static

Definition at line 1189 of file FadMPAssembly/fenl_functors.hpp.

◆ ElemNodeCount

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
const unsigned Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElementOptimized, CoeffFunctionType >::ElemNodeCount = base_type::ElemNodeCount
static

Definition at line 1190 of file FadMPAssembly/fenl_functors.hpp.


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