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

#include <fenl_functors.hpp>

Public Types

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 Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace > sparse_matrix_type
 
typedef sparse_matrix_type::StaticCrsGraphType sparse_graph_type
 
typedef sparse_matrix_type::values_type matrix_values_type
 
typedef Kokkos::View< scalar_type *, Kokkos::LayoutLeft, execution_spacevector_type
 
typedef LocalViewTraits< vector_typelocal_vector_view_traits
 
typedef LocalViewTraits< matrix_values_typelocal_matrix_view_traits
 
typedef local_vector_view_traits::local_view_type local_vector_type
 
typedef local_matrix_view_traits::local_view_type local_matrix_type
 
typedef local_vector_view_traits::local_value_type local_scalar_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 LocalViewTraits< elem_matrices_typelocal_elem_matrices_traits
 
typedef LocalViewTraits< elem_vectors_typelocal_elem_vectors_traits
 
typedef local_elem_matrices_traits::local_view_type local_elem_matrices_type
 
typedef local_elem_vectors_traits::local_view_type local_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 mesh_type &arg_mesh, const CoeffFunctionType &arg_coeff_function, const vector_type &arg_solution, const elem_graph_type &arg_elem_graph, const sparse_matrix_type &arg_jacobian, const vector_type &arg_residual, const Kokkos::Example::FENL::DeviceConfig arg_dev_config)
 
void apply () const
 
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
 
KOKKOS_INLINE_FUNCTION void contributeResidualJacobian (const local_scalar_type dof_values[], const double dpsidx[], const double dpsidy[], const double dpsidz[], const double detJ, const local_scalar_type coeff_k, const double integ_weight, const double bases_vals[], local_scalar_type elem_res[], local_scalar_type elem_mat[][FunctionCount]) const
 
KOKKOS_INLINE_FUNCTION void operator() (const typename TeamPolicy< execution_space >::member_type &dev) const
 
KOKKOS_INLINE_FUNCTION void operator() (const unsigned ielem, const unsigned ensemble_rank=0) 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
 
const CoeffFunctionType coeff_function
 
const Kokkos::Example::FENL::DeviceConfig dev_config
 

Static Public Attributes

static const bool use_team = local_vector_view_traits::use_team
 
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
 
static const unsigned FLOPS_transform_gradients
 

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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >

Definition at line 600 of file MPAssembly/fenl_functors.hpp.

Member Typedef Documentation

◆ mesh_type

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

Definition at line 607 of file MPAssembly/fenl_functors.hpp.

◆ element_data_type

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

Definition at line 608 of file MPAssembly/fenl_functors.hpp.

◆ execution_space

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

Definition at line 612 of file MPAssembly/fenl_functors.hpp.

◆ scalar_type

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

Definition at line 613 of file MPAssembly/fenl_functors.hpp.

◆ sparse_matrix_type

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

Definition at line 615 of file MPAssembly/fenl_functors.hpp.

◆ sparse_graph_type

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

Definition at line 616 of file MPAssembly/fenl_functors.hpp.

◆ matrix_values_type

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

Definition at line 617 of file MPAssembly/fenl_functors.hpp.

◆ vector_type

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

Definition at line 618 of file MPAssembly/fenl_functors.hpp.

◆ local_vector_view_traits

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

Definition at line 622 of file MPAssembly/fenl_functors.hpp.

◆ local_matrix_view_traits

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

Definition at line 623 of file MPAssembly/fenl_functors.hpp.

◆ local_vector_type

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

Definition at line 624 of file MPAssembly/fenl_functors.hpp.

◆ local_matrix_type

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

Definition at line 625 of file MPAssembly/fenl_functors.hpp.

◆ local_scalar_type

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

Definition at line 626 of file MPAssembly/fenl_functors.hpp.

◆ node_coord_type

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

Definition at line 637 of file MPAssembly/fenl_functors.hpp.

◆ elem_node_type

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

Definition at line 638 of file MPAssembly/fenl_functors.hpp.

◆ elem_matrices_type

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

Definition at line 639 of file MPAssembly/fenl_functors.hpp.

◆ elem_vectors_type

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

Definition at line 640 of file MPAssembly/fenl_functors.hpp.

◆ local_elem_matrices_traits

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

Definition at line 642 of file MPAssembly/fenl_functors.hpp.

◆ local_elem_vectors_traits

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

Definition at line 643 of file MPAssembly/fenl_functors.hpp.

◆ local_elem_matrices_type

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

Definition at line 644 of file MPAssembly/fenl_functors.hpp.

◆ local_elem_vectors_type

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

Definition at line 645 of file MPAssembly/fenl_functors.hpp.

◆ elem_graph_type

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

Definition at line 647 of file MPAssembly/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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::ElementComputation ( const ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType > & rhs)
inline

Definition at line 667 of file MPAssembly/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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::ElementComputation ( const mesh_type & arg_mesh,
const CoeffFunctionType & arg_coeff_function,
const vector_type & arg_solution,
const elem_graph_type & arg_elem_graph,
const sparse_matrix_type & arg_jacobian,
const vector_type & arg_residual,
const Kokkos::Example::FENL::DeviceConfig arg_dev_config )
inline

Definition at line 683 of file MPAssembly/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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::apply ( ) const
inline

Definition at line 705 of file MPAssembly/fenl_functors.hpp.

◆ transform_gradients()

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
KOKKOS_INLINE_FUNCTION double Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::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 728 of file MPAssembly/fenl_functors.hpp.

◆ contributeResidualJacobian()

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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::contributeResidualJacobian ( const local_scalar_type dof_values[],
const double dpsidx[],
const double dpsidy[],
const double dpsidz[],
const double detJ,
const local_scalar_type coeff_k,
const double integ_weight,
const double bases_vals[],
local_scalar_type elem_res[],
local_scalar_type elem_mat[][FunctionCount] ) const
inline

Definition at line 806 of file MPAssembly/fenl_functors.hpp.

◆ operator()() [1/2]

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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::operator() ( const typename TeamPolicy< execution_space >::member_type & dev) const
inline

Definition at line 860 of file MPAssembly/fenl_functors.hpp.

◆ operator()() [2/2]

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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::operator() ( const unsigned ielem,
const unsigned ensemble_rank = 0 ) const
inline

Definition at line 879 of file MPAssembly/fenl_functors.hpp.

Member Data Documentation

◆ use_team

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType , class CoeffFunctionType >
const bool Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::use_team = local_vector_view_traits::use_team
static

Definition at line 627 of file MPAssembly/fenl_functors.hpp.

◆ SpatialDim

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

Definition at line 629 of file MPAssembly/fenl_functors.hpp.

◆ TensorDim

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

Definition at line 630 of file MPAssembly/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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::ElemNodeCount = element_data_type::element_node_count
static

Definition at line 631 of file MPAssembly/fenl_functors.hpp.

◆ 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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::FunctionCount = element_data_type::function_count
static

Definition at line 632 of file MPAssembly/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 >, Kokkos::Example::FENL::CrsMatrix< ScalarType, ExecutionSpace >, CoeffFunctionType >::IntegrationCount = element_data_type::integration_count
static

Definition at line 633 of file MPAssembly/fenl_functors.hpp.

◆ elem_data

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

Definition at line 655 of file MPAssembly/fenl_functors.hpp.

◆ elem_node_ids

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

Definition at line 656 of file MPAssembly/fenl_functors.hpp.

◆ node_coords

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

Definition at line 657 of file MPAssembly/fenl_functors.hpp.

◆ elem_graph

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

Definition at line 658 of file MPAssembly/fenl_functors.hpp.

◆ elem_jacobians

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

Definition at line 659 of file MPAssembly/fenl_functors.hpp.

◆ elem_residuals

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

Definition at line 660 of file MPAssembly/fenl_functors.hpp.

◆ solution

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

Definition at line 661 of file MPAssembly/fenl_functors.hpp.

◆ residual

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

Definition at line 662 of file MPAssembly/fenl_functors.hpp.

◆ jacobian

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

Definition at line 663 of file MPAssembly/fenl_functors.hpp.

◆ coeff_function

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

Definition at line 664 of file MPAssembly/fenl_functors.hpp.

◆ dev_config

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

Definition at line 665 of file MPAssembly/fenl_functors.hpp.

◆ FLOPS_transform_gradients

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

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