Sacado Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <fenl_functors.hpp>
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 |
Definition at line 407 of file fenl_functors.hpp.
typedef Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::mesh_type |
Definition at line 411 of file fenl_functors.hpp.
typedef Kokkos::Example::HexElement_Data< mesh_type::ElemNode > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::element_data_type |
Definition at line 412 of file fenl_functors.hpp.
typedef ExecutionSpace Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::execution_space |
Definition at line 416 of file fenl_functors.hpp.
typedef ScalarType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::scalar_type |
Definition at line 417 of file fenl_functors.hpp.
typedef CrsMatrix< ScalarType , ExecutionSpace > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_matrix_type |
Definition at line 419 of file fenl_functors.hpp.
typedef sparse_matrix_type::StaticCrsGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_graph_type |
Definition at line 420 of file fenl_functors.hpp.
typedef Kokkos::View< scalar_type* , Kokkos::LayoutLeft, execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::vector_type |
Definition at line 421 of file fenl_functors.hpp.
typedef mesh_type::node_coord_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::node_coord_type |
Definition at line 433 of file fenl_functors.hpp.
typedef mesh_type::elem_node_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_node_type |
Definition at line 434 of file fenl_functors.hpp.
typedef Kokkos::View< scalar_type*[FunctionCount][FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_matrices_type |
Definition at line 435 of file fenl_functors.hpp.
typedef Kokkos::View< scalar_type*[FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_vectors_type |
Definition at line 436 of file fenl_functors.hpp.
typedef NodeNodeGraph< elem_node_type , sparse_graph_type , ElemNodeCount >::ElemGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_graph_type |
Definition at line 438 of file fenl_functors.hpp.
typedef Kokkos::Example::BoxElemFixture< ExecutionSpace, Order, CoordinateMap > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::mesh_type |
Definition at line 411 of file view/fenl_functors.hpp.
typedef Kokkos::Example::HexElement_Data< mesh_type::ElemNode > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::element_data_type |
Definition at line 412 of file view/fenl_functors.hpp.
typedef ExecutionSpace Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::execution_space |
Definition at line 416 of file view/fenl_functors.hpp.
typedef ScalarType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::scalar_type |
Definition at line 417 of file view/fenl_functors.hpp.
typedef CrsMatrix< ScalarType , ExecutionSpace > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_matrix_type |
Definition at line 419 of file view/fenl_functors.hpp.
typedef sparse_matrix_type::StaticCrsGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::sparse_graph_type |
Definition at line 420 of file view/fenl_functors.hpp.
typedef Kokkos::View< scalar_type* , Kokkos::LayoutLeft, execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::vector_type |
Definition at line 421 of file view/fenl_functors.hpp.
typedef mesh_type::node_coord_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::node_coord_type |
Definition at line 433 of file view/fenl_functors.hpp.
typedef mesh_type::elem_node_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_node_type |
Definition at line 434 of file view/fenl_functors.hpp.
typedef Kokkos::View< scalar_type*[FunctionCount][FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_matrices_type |
Definition at line 435 of file view/fenl_functors.hpp.
typedef Kokkos::View< scalar_type*[FunctionCount] , execution_space > Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_vectors_type |
Definition at line 436 of file view/fenl_functors.hpp.
typedef NodeNodeGraph< elem_node_type , sparse_graph_type , ElemNodeCount >::ElemGraphType Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_graph_type |
Definition at line 438 of file view/fenl_functors.hpp.
|
inline |
Definition at line 456 of file fenl_functors.hpp.
|
inline |
Definition at line 468 of file fenl_functors.hpp.
|
inline |
Definition at line 456 of file view/fenl_functors.hpp.
|
inline |
Definition at line 468 of file view/fenl_functors.hpp.
|
inline |
Definition at line 487 of file fenl_functors.hpp.
|
inline |
Definition at line 487 of file view/fenl_functors.hpp.
|
static |
Definition at line 425 of file fenl_functors.hpp.
|
static |
Definition at line 426 of file fenl_functors.hpp.
|
static |
Definition at line 427 of file fenl_functors.hpp.
|
static |
Definition at line 428 of file fenl_functors.hpp.
|
static |
Definition at line 429 of file fenl_functors.hpp.
const element_data_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_data |
Definition at line 446 of file fenl_functors.hpp.
const elem_node_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_node_ids |
Definition at line 447 of file fenl_functors.hpp.
const node_coord_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::node_coords |
Definition at line 448 of file fenl_functors.hpp.
const elem_graph_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_graph |
Definition at line 449 of file fenl_functors.hpp.
const elem_matrices_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_jacobians |
Definition at line 450 of file fenl_functors.hpp.
const elem_vectors_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::elem_residuals |
Definition at line 451 of file fenl_functors.hpp.
const vector_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::solution |
Definition at line 452 of file fenl_functors.hpp.
const vector_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::residual |
Definition at line 453 of file fenl_functors.hpp.
const sparse_matrix_type Kokkos::Example::FENL::ElementComputationBase< ExecutionSpace, Order, CoordinateMap, ScalarType >::jacobian |
Definition at line 454 of file fenl_functors.hpp.