Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Macros | Typedefs | Functions | Variables
Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp File Reference
#include "Teuchos_UnitTestHelpers.hpp"
#include "Stokhos_UnitTestHelpers.hpp"
#include "Stokhos_Sacado_Kokkos_MP_Vector.hpp"
#include "Stokhos_Ensemble_Sizes.hpp"
#include "Kokkos_CrsMatrix_MP_Vector.hpp"
#include "Kokkos_CrsMatrix_MP_Vector_Cuda.hpp"
#include "Kokkos_Core.hpp"
Include dependency graph for Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

struct  ScalarTol< Scalar >
 
struct  ScalarTol< float >
 
struct  ScalarTol< double >
 
struct  ReplaceDiagonalValuesKernel< MatrixType >
 
struct  AddDiagonalValuesKernel< MatrixType >
 
struct  AddDiagonalValuesAtomicKernel< MatrixType >
 
struct  RankTypeSelector< ViewType, OrdinalType, I >
 
struct  RankTypeSelector< ViewType, OrdinalType, 1 >
 
struct  RankTypeSelector< ViewType, OrdinalType, 0 >
 
struct  Kokkos_MV_Multiply_Op
 
struct  Stokhos_MV_Multiply_Op< Tag >
 

Macros

#define CRSMATRIX_MP_VECTOR_TESTS_MATRIXSCALAR(SCALAR)
 
#define CRSMATRIX_MP_VECTOR_TESTS_STORAGE(STORAGE)
 
#define CRSMATRIX_MP_VECTOR_TESTS_ORDINAL_SCALAR_DEVICE(ORDINAL, SCALAR, DEVICE)
 
#define CRSMATRIX_MP_VECTOR_TESTS_DEVICE(DEVICE)   CRSMATRIX_MP_VECTOR_TESTS_ORDINAL_SCALAR_DEVICE( int, double, DEVICE )
 

Typedefs

typedef Kokkos_MV_Multiply_Op KokkosMultiply
 
typedef Stokhos_MV_Multiply_Op
< Stokhos::DefaultMultiply
DefaultMultiply
 

Functions

template<typename IntType >
IntType map_fem_graph_coord (const IntType &N, const IntType &i, const IntType &j, const IntType &k)
 
template<typename ordinal >
ordinal generate_fem_graph (ordinal N, std::vector< std::vector< ordinal > > &graph)
 
template<typename scalar , typename ordinal >
scalar generate_matrix_coefficient (const ordinal nFEM, const ordinal nStoch, const ordinal iRowFEM, const ordinal iColFEM, const ordinal iStoch)
 
template<typename scalar , typename ordinal >
scalar generate_vector_coefficient (const ordinal nFEM, const ordinal nStoch, const ordinal iColFEM, const ordinal iStoch)
 
template<typename array_type , typename scalar_type >
bool compare_rank_2_views (const array_type &y, const array_type &y_exp, const scalar_type rel_tol, const scalar_type abs_tol, Teuchos::FancyOStream &out)
 
template<typename MatrixType >
MatrixType buildDiagonalMatrix (typename MatrixType::ordinal_type nrow, typename MatrixType::ordinal_type mp_vector_size)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (Kokkos_CrsMatrix_MP, ReplaceValues, MatrixScalar)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (Kokkos_CrsMatrix_MP, SumIntoValues, MatrixScalar)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL (Kokkos_CrsMatrix_MP, SumIntoValuesAtomic, MatrixScalar)
 
template<typename VectorType , typename Multiply >
bool test_embedded_vector (const typename VectorType::ordinal_type nGrid, const typename VectorType::ordinal_type stoch_length, KokkosSparse::DeviceConfig dev_config, Multiply multiply_op, Teuchos::FancyOStream &out)
 

Variables

const unsigned VectorSize = STOKHOS_DEFAULT_ENSEMBLE_SIZE
 

Macro Definition Documentation

#define CRSMATRIX_MP_VECTOR_TESTS_MATRIXSCALAR (   SCALAR)
Value:
Kokkos_CrsMatrix_MP, ReplaceValues, SCALAR ) \
TEUCHOS_UNIT_TEST_TEMPLATE_1_INSTANT( \
Kokkos_CrsMatrix_MP, SumIntoValues, SCALAR ) \
TEUCHOS_UNIT_TEST_TEMPLATE_1_INSTANT( \
Kokkos_CrsMatrix_MP, SumIntoValuesAtomic, SCALAR )
#define TEUCHOS_UNIT_TEST_TEMPLATE_1_INSTANT(TEST_GROUP, TEST_NAME, TYPE)

Definition at line 577 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

#define CRSMATRIX_MP_VECTOR_TESTS_STORAGE (   STORAGE)
Value:
typedef Sacado::MP::Vector<STORAGE> MP_Vector_ ## STORAGE; \
#define CRSMATRIX_MP_VECTOR_TESTS_MATRIXSCALAR(SCALAR)

Definition at line 585 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

#define CRSMATRIX_MP_VECTOR_TESTS_ORDINAL_SCALAR_DEVICE (   ORDINAL,
  SCALAR,
  DEVICE 
)
#define CRSMATRIX_MP_VECTOR_TESTS_DEVICE (   DEVICE)    CRSMATRIX_MP_VECTOR_TESTS_ORDINAL_SCALAR_DEVICE( int, double, DEVICE )

Definition at line 595 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

Typedef Documentation

Definition at line 574 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

Definition at line 575 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

Function Documentation

template<typename IntType >
IntType map_fem_graph_coord ( const IntType &  N,
const IntType &  i,
const IntType &  j,
const IntType &  k 
)
inline

Definition at line 24 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

template<typename ordinal >
ordinal generate_fem_graph ( ordinal  N,
std::vector< std::vector< ordinal > > &  graph 
)
inline

Definition at line 34 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

template<typename scalar , typename ordinal >
scalar generate_matrix_coefficient ( const ordinal  nFEM,
const ordinal  nStoch,
const ordinal  iRowFEM,
const ordinal  iColFEM,
const ordinal  iStoch 
)
inline

Definition at line 68 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

template<typename scalar , typename ordinal >
scalar generate_vector_coefficient ( const ordinal  nFEM,
const ordinal  nStoch,
const ordinal  iColFEM,
const ordinal  iStoch 
)
inline

Definition at line 85 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

template<typename array_type , typename scalar_type >
bool compare_rank_2_views ( const array_type &  y,
const array_type &  y_exp,
const scalar_type  rel_tol,
const scalar_type  abs_tol,
Teuchos::FancyOStream out 
)

Definition at line 103 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

template<typename MatrixType >
MatrixType buildDiagonalMatrix ( typename MatrixType::ordinal_type  nrow,
typename MatrixType::ordinal_type  mp_vector_size 
)

Definition at line 142 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL ( Kokkos_CrsMatrix_MP  ,
ReplaceValues  ,
MatrixScalar   
)

Definition at line 318 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL ( Kokkos_CrsMatrix_MP  ,
SumIntoValues  ,
MatrixScalar   
)

Definition at line 338 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL ( Kokkos_CrsMatrix_MP  ,
SumIntoValuesAtomic  ,
MatrixScalar   
)

Definition at line 358 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

template<typename VectorType , typename Multiply >
bool test_embedded_vector ( const typename VectorType::ordinal_type  nGrid,
const typename VectorType::ordinal_type  stoch_length,
KokkosSparse::DeviceConfig  dev_config,
Multiply  multiply_op,
Teuchos::FancyOStream out 
)

Definition at line 408 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.

Variable Documentation

const unsigned VectorSize = STOKHOS_DEFAULT_ENSEMBLE_SIZE

Definition at line 316 of file Stokhos_KokkosCrsMatrixMPVectorUnitTest.hpp.