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 | Public Attributes | Static Public Attributes | List of all members
Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType > Class Template Reference

#include <fenl_functors.hpp>

Inheritance diagram for Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >:
Inheritance graph
[legend]

Public Types

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

 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
 

Public Attributes

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 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
 

Detailed Description

template<class ExecutionSpace, BoxElemPart::ElemOrder Order, class CoordinateMap, typename ScalarType>
class Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >

Definition at line 434 of file fenl_functors.hpp.

Member Typedef Documentation

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::mesh_type

Definition at line 438 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::Example::HexElement_Data< mesh_type::ElemNode > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::element_data_type

Definition at line 439 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef ExecutionSpace Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::execution_space

Definition at line 443 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef ScalarType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::scalar_type

Definition at line 444 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef CrsMatrix< ScalarType , ExecutionSpace > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_matrix_type

Definition at line 446 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef sparse_matrix_type::StaticCrsGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_graph_type

Definition at line 447 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::View< scalar_type* , Kokkos::LayoutLeft, execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::vector_type

Definition at line 448 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef mesh_type::node_coord_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::node_coord_type

Definition at line 460 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef mesh_type::elem_node_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_node_type

Definition at line 461 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::View< scalar_type*[FunctionCount][FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_matrices_type

Definition at line 462 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::View< scalar_type*[FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_vectors_type

Definition at line 463 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef NodeNodeGraph< elem_node_type , sparse_graph_type , ElemNodeCount >::ElemGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_graph_type

Definition at line 465 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::mesh_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::Example::HexElement_Data< mesh_type::ElemNode > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::element_data_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef ExecutionSpace Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::execution_space

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef ScalarType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::scalar_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef CrsMatrix< ScalarType , ExecutionSpace > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_matrix_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef sparse_matrix_type::StaticCrsGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_graph_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::View< scalar_type* , Kokkos::LayoutLeft, execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::vector_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef mesh_type::node_coord_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::node_coord_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef mesh_type::elem_node_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_node_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::View< scalar_type*[FunctionCount][FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_matrices_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef Kokkos::View< scalar_type*[FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_vectors_type

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

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
typedef NodeNodeGraph< elem_node_type , sparse_graph_type , ElemNodeCount >::ElemGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_graph_type

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

Constructor & Destructor Documentation

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

Definition at line 483 of file fenl_functors.hpp.

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

Definition at line 495 of file fenl_functors.hpp.

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

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

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

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

Member Function Documentation

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
KOKKOS_INLINE_FUNCTION double Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::transform_gradients ( const double  grad[][FunctionCount],
const double  x[],
const double  y[],
const double  z[],
double  dpsidx[],
double  dpsidy[],
double  dpsidz[] 
) const
inline

Definition at line 514 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
KOKKOS_INLINE_FUNCTION double Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::transform_gradients ( const double  grad[][FunctionCount],
const double  x[],
const double  y[],
const double  z[],
double  dpsidx[],
double  dpsidy[],
double  dpsidz[] 
) const
inline

Definition at line 514 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::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::SpatialDim = element_data_type::spatial_dimension
static

Definition at line 452 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
static const unsigned Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::TensorDim = SpatialDim * SpatialDim
static

Definition at line 453 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
static const unsigned Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::ElemNodeCount = element_data_type::element_node_count
static

Definition at line 454 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
static const unsigned Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::FunctionCount = element_data_type::function_count
static

Definition at line 455 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
static const unsigned Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::IntegrationCount = element_data_type::integration_count
static

Definition at line 456 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const element_data_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_data

Definition at line 473 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const elem_node_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_node_ids

Definition at line 474 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const node_coord_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::node_coords

Definition at line 475 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const elem_graph_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_graph

Definition at line 476 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const elem_matrices_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_jacobians

Definition at line 477 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const elem_vectors_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_residuals

Definition at line 478 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const vector_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::solution

Definition at line 479 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const vector_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::residual

Definition at line 480 of file fenl_functors.hpp.

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
const sparse_matrix_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::jacobian

Definition at line 481 of file fenl_functors.hpp.


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