Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
Macros | Functions | Variables
Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp File Reference
#include "Teuchos_UnitTestHelpers.hpp"
#include "Stokhos_UnitTestHelpers.hpp"
#include "Teuchos_XMLParameterListCoreHelpers.hpp"
#include "Stokhos_Tpetra_MP_Vector.hpp"
#include "Stokhos_Tpetra_Utilities_MP_Vector.hpp"
#include "Tpetra_ConfigDefs.hpp"
#include "Tpetra_DefaultPlatform.hpp"
#include "Tpetra_Map.hpp"
#include "Tpetra_MultiVector.hpp"
#include "Tpetra_Vector.hpp"
#include "Tpetra_CrsGraph.hpp"
#include "Tpetra_CrsMatrix.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, 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_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, Storage, LocalOrdinal, GlobalOrdinal, Node)
 

Variables

const int VectorSize = 16
 

Macro Definition Documentation

◆ CRSMATRIX_MP_VECTOR_TESTS_SLGN

#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, 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_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, S, LO, GO, N )
TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix, MatVec, double, int, int, Node) TEUCHOS_UNIT_TEST_TEMPLATE_4_INSTANT(Tpetra_CrsMatrix
BelosGMRES

Definition at line 2044 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ CRSMATRIX_MP_VECTOR_TESTS_N_SFS

#define CRSMATRIX_MP_VECTOR_TESTS_N_SFS (   N)
Value:
CRSMATRIX_MP_VECTOR_TESTS_SLGN(SFS, int, int, N)
Statically allocated storage class.
Kokkos::HostSpace::execution_space type

Definition at line 2060 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ CRSMATRIX_MP_VECTOR_TESTS_N

#define CRSMATRIX_MP_VECTOR_TESTS_N (   N)    CRSMATRIX_MP_VECTOR_TESTS_N_SFS(N)

Function Documentation

◆ generate_vector_coefficient()

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

◆ generate_multi_vector_coefficient()

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

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [1/14]

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

Definition at line 129 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [2/14]

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

Definition at line 212 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [3/14]

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

Definition at line 319 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [4/14]

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

Definition at line 411 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [5/14]

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

Definition at line 531 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [6/14]

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

Definition at line 660 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [7/14]

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

Definition at line 786 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [8/14]

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

Definition at line 925 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [9/14]

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

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [10/14]

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

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [11/14]

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

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [12/14]

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

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [13/14]

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

◆ TEUCHOS_UNIT_TEST_TEMPLATE_4_DECL() [14/14]

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

Variable Documentation

◆ VectorSize

const int VectorSize = 16

Definition at line 123 of file Stokhos_TpetraCrsMatrixMPVectorUnitTest.hpp.