Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Macros | Functions | Variables
Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp File Reference
#include "Teuchos_UnitTestHelpers.hpp"
#include "Stokhos_UnitTestHelpers.hpp"
#include "Stokhos_Ensemble_Sizes.hpp"
#include "Teuchos_XMLParameterListCoreHelpers.hpp"
#include "Stokhos_Tpetra_MP_Vector.hpp"
#include "Stokhos_Tpetra_Utilities_MP_Vector.hpp"
#include "Tpetra_Core.hpp"
#include "Tpetra_Map.hpp"
#include "Tpetra_MultiVector.hpp"
#include "Tpetra_Vector.hpp"
#include "Tpetra_CrsGraph.hpp"
#include "Tpetra_CrsMatrix.hpp"
#include "Tpetra_Details_WrappedDualView.hpp"
#include "Stokhos_Tpetra_CG.hpp"
Include dependency graph for Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Macros

#define CRSMATRIX_MP_VECTOR_TESTS_SLGN(S, LO, GO, N)
 
#define CRSMATRIX_MP_VECTOR_TESTS_N_SFS(N)
 
#define CRSMATRIX_MP_VECTOR_TESTS_N(N)   CRSMATRIX_MP_VECTOR_TESTS_N_SFS(N)
 

Functions

template<typename scalar , typename ordinal >
scalar generate_vector_coefficient (const ordinal nFEM, const ordinal nStoch, const ordinal iColFEM, const ordinal iStoch)
 
template<typename scalar , typename ordinal >
scalar generate_multi_vector_coefficient (const ordinal nFEM, const ordinal nVec, const ordinal nStoch, const ordinal iColFEM, const ordinal iVec, const ordinal iStoch)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, VectorAdd, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, VectorDot, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, MultiVectorAdd, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, MultiVectorDot, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, MultiVectorDotSub, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, MatrixVectorMultiply, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, MatrixMultiVectorMultiply, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Flatten, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, WrappedDualView, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, SimpleCG, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, SimplePCG_Muelu, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, BelosGMRES, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, BelosGMRES_DGKS, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, BelosGMRES_ICGS, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, BelosGMRES_IMGS, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, BelosGMRES_RILUK, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, BelosCG_Muelu, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_basker, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_klu2, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_superlu_dist, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_superlu_mt, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_superlu, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_pardisomkl, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_lapack, Storage, LocalOrdinal, GlobalOrdinal, Node)
 
 TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL (Tpetra_CrsMatrix_MP, Amesos2_cholmod, Storage, LocalOrdinal, GlobalOrdinal, Node)
 

Variables

const int VectorSize = STOKHOS_DEFAULT_ENSEMBLE_SIZE
 

Macro Definition Documentation

#define CRSMATRIX_MP_VECTOR_TESTS_SLGN (   S,
  LO,
  GO,
 
)
Value:
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, VectorAdd, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, VectorDot, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, MultiVectorAdd, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, MultiVectorDot, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, MultiVectorDotSub, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, MatrixVectorMultiply, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, MatrixMultiVectorMultiply, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, WrappedDualView, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Flatten, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, SimpleCG, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, SimplePCG_Muelu, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, BelosGMRES, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, BelosGMRES_DGKS, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, BelosGMRES_ICGS, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, BelosGMRES_IMGS, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, BelosGMRES_RILUK, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, BelosCG_Muelu, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_basker, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_klu2, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_superlu_dist, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_superlu_mt, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_superlu, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_pardisomkl, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_lapack, S, LO, GO, N ) \
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix_MP, Amesos2_cholmod, S, LO, GO, N )
#define TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(TEST_GROUP, TEST_NAME, TYPE1, TYPE2, TYPE3, TYPE4)
BelosGMRES

Definition at line 2499 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

#define CRSMATRIX_MP_VECTOR_TESTS_N_SFS (   N)
Value:
using default_global_ordinal_type = ::Tpetra::Map<>::global_ordinal_type; \
using default_local_ordinal_type = ::Tpetra::Map<>::local_ordinal_type; \
CRSMATRIX_MP_VECTOR_TESTS_SLGN(SFS, default_local_ordinal_type, default_global_ordinal_type, N)
Statically allocated storage class.
#define CRSMATRIX_MP_VECTOR_TESTS_SLGN(S, LO, GO, N)
Kokkos::HostSpace::execution_space type

Definition at line 2526 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

#define CRSMATRIX_MP_VECTOR_TESTS_N (   N)    CRSMATRIX_MP_VECTOR_TESTS_N_SFS(N)

Function Documentation

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 57 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

template<typename scalar , typename ordinal >
scalar generate_multi_vector_coefficient ( const ordinal  nFEM,
const ordinal  nVec,
const ordinal  nStoch,
const ordinal  iColFEM,
const ordinal  iVec,
const ordinal  iStoch 
)
inline

Definition at line 70 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
VectorAdd  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 93 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
VectorDot  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 171 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
MultiVectorAdd  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 273 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
MultiVectorDot  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 360 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
MultiVectorDotSub  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 475 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
MatrixVectorMultiply  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 599 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
MatrixMultiVectorMultiply  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 721 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Flatten  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 856 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
WrappedDualView  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Definition at line 982 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
SimpleCG  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
SimplePCG_Muelu  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
BelosGMRES  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
BelosGMRES_DGKS  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
BelosGMRES_ICGS  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
BelosGMRES_IMGS  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
BelosGMRES_RILUK  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
BelosCG_Muelu  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_basker  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_klu2  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_superlu_dist  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_superlu_mt  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_superlu  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_pardisomkl  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_lapack  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)
TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL ( Tpetra_CrsMatrix_MP  ,
Amesos2_cholmod  ,
Storage  ,
LocalOrdinal  ,
GlobalOrdinal  ,
Node   
)

Variable Documentation

const int VectorSize = STOKHOS_DEFAULT_ENSEMBLE_SIZE

Definition at line 88 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.