Sacado Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
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 >, FadQuadPoint > Class Template Reference

#include <fenl_functors.hpp>

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

Public Types

typedef ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analyticbase_type
 
typedef base_type::scalar_type scalar_type
 
typedef base_type::execution_space execution_space
 
typedef Sacado::Fad::SFad< scalar_type, 4 > fad_scalar_type
 
typedef ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analyticbase_type
 
typedef base_type::scalar_type scalar_type
 
typedef base_type::execution_space execution_space
 
typedef base_type::elem_vec_type elem_vec_type
 
typedef base_type::elem_mat_type elem_mat_type
 
typedef Sacado::Fad::SFad< scalar_type, 4 > fad_scalar_type
 
- Public Types inherited from Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analytic >
typedef ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType > base_type
 
typedef base_type::scalar_type scalar_type
 
typedef base_type::execution_space execution_space
 
typedef ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType > base_type
 
typedef base_type::scalar_type scalar_type
 
typedef base_type::execution_space execution_space
 
typedef Kokkos::View< scalar_type[FunctionCount], Kokkos::LayoutRight, execution_space, Kokkos::MemoryUnmanaged > elem_vec_type
 
typedef Kokkos::View< scalar_type[FunctionCount][FunctionCount], Kokkos::LayoutRight, execution_space, Kokkos::MemoryUnmanaged > elem_mat_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
 
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 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 computeElementResidualJacobian (const scalar_type dof_values[], const double x[], const double y[], const double z[], scalar_type elem_res[], scalar_type elem_mat[][FunctionCount]) 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 computeElementResidualJacobian (const elem_vec_type &dof_values, const double x[], const double y[], const double z[], const elem_vec_type &elem_res, const elem_mat_type &elem_mat) 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 >, Analytic >
 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, scalar_type val[], unsigned node_index[], double x[], double y[], double z[], scalar_type res[], scalar_type mat[][FunctionCount]) const
 
KOKKOS_INLINE_FUNCTION void scatterResidual (const unsigned ielem, const unsigned node_index[], const scalar_type res[], const scalar_type mat[][FunctionCount]) const
 
KOKKOS_INLINE_FUNCTION void computeElementResidualJacobian (const scalar_type dof_values[], const double x[], const double y[], const double z[], scalar_type elem_res[], scalar_type elem_mat[][FunctionCount]) 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 elem_mat_type &mat) const
 
KOKKOS_INLINE_FUNCTION void scatterResidual (const unsigned ielem, const unsigned node_index[], const elem_vec_type &res, const elem_mat_type &mat) const
 
KOKKOS_INLINE_FUNCTION void computeElementResidualJacobian (const elem_vec_type &dof_values, const double x[], const double y[], const double z[], const elem_vec_type &elem_res, const elem_mat_type &elem_mat) 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::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, Analytic >
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 >, FadQuadPoint >

Definition at line 1110 of file fenl_assembly/fenl_functors.hpp.

Member Typedef Documentation

◆ base_type [1/2]

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

Definition at line 1121 of file fenl_assembly/fenl_functors.hpp.

◆ scalar_type [1/2]

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 >, FadQuadPoint >::scalar_type

Definition at line 1123 of file fenl_assembly/fenl_functors.hpp.

◆ execution_space [1/2]

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 >, FadQuadPoint >::execution_space

Definition at line 1124 of file fenl_assembly/fenl_functors.hpp.

◆ fad_scalar_type [1/2]

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

Definition at line 1130 of file fenl_assembly/fenl_functors.hpp.

◆ base_type [2/2]

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

Definition at line 1134 of file fenl_assembly_view/fenl_functors.hpp.

◆ scalar_type [2/2]

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 >, FadQuadPoint >::scalar_type

Definition at line 1136 of file fenl_assembly_view/fenl_functors.hpp.

◆ execution_space [2/2]

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 >, FadQuadPoint >::execution_space

Definition at line 1137 of file fenl_assembly_view/fenl_functors.hpp.

◆ elem_vec_type

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

Definition at line 1143 of file fenl_assembly_view/fenl_functors.hpp.

◆ elem_mat_type

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

Definition at line 1144 of file fenl_assembly_view/fenl_functors.hpp.

◆ fad_scalar_type [2/2]

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

Definition at line 1146 of file fenl_assembly_view/fenl_functors.hpp.

Constructor & Destructor Documentation

◆ ElementComputation() [1/4]

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

Definition at line 1132 of file fenl_assembly/fenl_functors.hpp.

◆ ElementComputation() [2/4]

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadQuadPoint >::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 1134 of file fenl_assembly/fenl_functors.hpp.

◆ ElementComputation() [3/4]

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

Definition at line 1148 of file fenl_assembly_view/fenl_functors.hpp.

◆ ElementComputation() [4/4]

template<class ExecutionSpace , BoxElemPart::ElemOrder Order, class CoordinateMap , typename ScalarType >
Kokkos::Example::FENL::ElementComputation< Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap >, CrsMatrix< ScalarType, ExecutionSpace >, FadQuadPoint >::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 1150 of file fenl_assembly_view/fenl_functors.hpp.

Member Function Documentation

◆ apply() [1/2]

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

Definition at line 1145 of file fenl_assembly/fenl_functors.hpp.

◆ computeElementResidualJacobian() [1/2]

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 >, FadQuadPoint >::computeElementResidualJacobian ( const scalar_type dof_values[],
const double x[],
const double y[],
const double z[],
scalar_type elem_res[],
scalar_type elem_mat[][FunctionCount] ) const
inline

Definition at line 1152 of file fenl_assembly/fenl_functors.hpp.

◆ operator()() [1/2]

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 >, FadQuadPoint >::operator() ( const unsigned ielem) const
inline

Definition at line 1223 of file fenl_assembly/fenl_functors.hpp.

◆ apply() [2/2]

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

Definition at line 1161 of file fenl_assembly_view/fenl_functors.hpp.

◆ computeElementResidualJacobian() [2/2]

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 >, FadQuadPoint >::computeElementResidualJacobian ( const elem_vec_type & dof_values,
const double x[],
const double y[],
const double z[],
const elem_vec_type & elem_res,
const elem_mat_type & elem_mat ) const
inline

Definition at line 1168 of file fenl_assembly_view/fenl_functors.hpp.

◆ operator()() [2/2]

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 >, FadQuadPoint >::operator() ( const unsigned ielem) const
inline

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

Member Data Documentation

◆ FunctionCount

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 >, FadQuadPoint >::FunctionCount = base_type::FunctionCount
static

Definition at line 1126 of file fenl_assembly/fenl_functors.hpp.

◆ IntegrationCount

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 >, FadQuadPoint >::IntegrationCount = base_type::IntegrationCount
static

Definition at line 1127 of file fenl_assembly/fenl_functors.hpp.

◆ ElemNodeCount

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 >, FadQuadPoint >::ElemNodeCount = base_type::ElemNodeCount
static

Definition at line 1128 of file fenl_assembly/fenl_functors.hpp.


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