Sacado Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
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 >, FadElement > Class Template Reference

#include <fenl_functors.hpp>

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

Public Types

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::SFad
< scalar_type, FunctionCount
fad_scalar_type
 
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::SFad
< scalar_type, FunctionCount
fad_scalar_type
 
typedef Kokkos::View
< fad_scalar_type
*, Kokkos::LayoutRight,
execution_space,
Kokkos::MemoryUnmanaged > 
elem_vec_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::ElemNode
element_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_space
vector_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_space
elem_matrices_type
 
typedef Kokkos::View
< scalar_type *[FunctionCount],
execution_space
elem_vectors_type
 
typedef NodeNodeGraph
< elem_node_type,
sparse_graph_type,
ElemNodeCount >::ElemGraphType 
elem_graph_type
 
typedef
Kokkos::Example::BoxElemFixture
< ExecutionSpace, Order,
CoordinateMap > 
mesh_type
 
typedef
Kokkos::Example::HexElement_Data
< mesh_type::ElemNode
element_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_space
vector_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_space
elem_matrices_type
 
typedef Kokkos::View
< scalar_type *[FunctionCount],
execution_space
elem_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 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)
 
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
 
KOKKOS_INLINE_FUNCTION void computeElementResidual (const fad_scalar_type dof_values[], const double x[], const double y[], const double z[], fad_scalar_type elem_res[]) const
 
KOKKOS_INLINE_FUNCTION void operator() (const unsigned ielem) const
 
 ElementComputation (const ElementComputation &rhs)
 
 ElementComputation (const typename base_type::mesh_type &arg_mesh, 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)
 
void apply () const
 
KOKKOS_INLINE_FUNCTION void gatherSolution (const unsigned ielem, const elem_vec_type &val, unsigned node_index[], double x[], double y[], double z[], const elem_vec_type &res) const
 
KOKKOS_INLINE_FUNCTION void scatterResidual (const unsigned ielem, const unsigned node_index[], const elem_vec_type &res) const
 
KOKKOS_INLINE_FUNCTION void computeElementResidual (const elem_vec_type &dof_values, const double x[], const double y[], const double z[], const elem_vec_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
 
 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::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::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 Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement >

Definition at line 798 of file fenl_functors.hpp.

Member Typedef Documentation

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

Definition at line 806 of file fenl_functors.hpp.

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

Definition at line 808 of file fenl_functors.hpp.

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

Definition at line 809 of file fenl_functors.hpp.

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

Definition at line 815 of file fenl_functors.hpp.

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

Definition at line 809 of file view/fenl_functors.hpp.

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

Definition at line 811 of file view/fenl_functors.hpp.

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

Definition at line 812 of file view/fenl_functors.hpp.

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

Definition at line 818 of file view/fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::View<fad_scalar_type*,Kokkos::LayoutRight,execution_space,Kokkos::MemoryUnmanaged> Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement >::elem_vec_type

Definition at line 821 of file view/fenl_functors.hpp.

Constructor & Destructor Documentation

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

Definition at line 817 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement >::ElementComputation ( const typename base_type::mesh_type arg_mesh,
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 
)
inline

Definition at line 819 of file fenl_functors.hpp.

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

Definition at line 823 of file view/fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement >::ElementComputation ( const typename base_type::mesh_type arg_mesh,
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 
)
inline

Definition at line 825 of file view/fenl_functors.hpp.

Member Function Documentation

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

Definition at line 830 of file fenl_functors.hpp.

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

Definition at line 837 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
KOKKOS_INLINE_FUNCTION void Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement >::scatterResidual ( const unsigned  ielem,
const unsigned  node_index[],
fad_scalar_type  res[] 
) const
inline

Definition at line 858 of file fenl_functors.hpp.

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

Definition at line 879 of file fenl_functors.hpp.

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

Definition at line 937 of file fenl_functors.hpp.

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

Definition at line 836 of file view/fenl_functors.hpp.

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

Definition at line 843 of file view/fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
KOKKOS_INLINE_FUNCTION void Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadElement >::scatterResidual ( const unsigned  ielem,
const unsigned  node_index[],
const elem_vec_type res 
) const
inline

Definition at line 865 of file view/fenl_functors.hpp.

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

Definition at line 886 of file view/fenl_functors.hpp.

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

Definition at line 944 of file view/fenl_functors.hpp.

Member Data Documentation

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

Definition at line 811 of file fenl_functors.hpp.

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

Definition at line 812 of file fenl_functors.hpp.

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

Definition at line 813 of file fenl_functors.hpp.


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