Stratimikos Package Browser (Single Doxygen Collection)  Version of the Day
Namespaces | Classes | Typedefs | Enumerations | Functions | Variables
Thyra Namespace Reference

Namespaces

 Amesos
 

Classes

class  AmesosLinearOpWithSolve
 Concrete LinearOpWithSolveBase subclass that adapts any Amesos_BaseSolver object. More...
 
class  AmesosLinearOpWithSolveFactory
 Concrete LinearOpWithSolveFactoryBase adapter subclass that uses Amesos direct solvers. More...
 
class  AztecOOLinearOpWithSolve
 Concrete LinearOpWithSolveBase subclass implemented using AztecOO. More...
 
class  AztecOOLinearOpWithSolveFactory
 LinearOpWithSolveFactoryBase subclass implemented in terms of AztecOO. More...
 
class  BelosLinearOpWithSolve
 Concrete LinearOpWithSolveBase subclass in terms of Belos. More...
 
class  BelosLinearOpWithSolveFactory
 LinearOpWithSolveFactoryBase subclass implemented in terms of Belos. More...
 
class  GeneralSolveCriteriaBelosStatusTest
 Subclass of Belos::StatusTest that implements every possible form of SolveCriteria that exists by forcing the computation of X and R. More...
 
class  IfpackPreconditionerFactory
 Concrete preconditioner factory subclass based on Ifpack. More...
 
class  MLPreconditionerFactory
 Concrete preconditioner factory subclass based on ML. More...
 
class  MockMaxNormInfEpsReductionFunctional
 Mock max(NormInf, eps) ReductionFunctional subclass used for unit testing. More...
 
class  MockNormInfReductionFunctional
 Mock NormInf ReductionFunctional subclass used for unit testing. More...
 
class  TsqrAdaptor
 Stub adaptor from Thyra::MultiVectorBase to TSQR. More...
 

Typedefs

typedef Stratimikos::DefaultLinearSolverBuilder DefaultRealLinearSolverBuilder
 

Enumerations

enum  EBelosSolverType {
  SOLVER_TYPE_BLOCK_GMRES, SOLVER_TYPE_PSEUDO_BLOCK_GMRES, SOLVER_TYPE_BLOCK_CG, SOLVER_TYPE_PSEUDO_BLOCK_CG,
  SOLVER_TYPE_PSEUDO_BLOCK_STOCHASTIC_CG, SOLVER_TYPE_GCRODR, SOLVER_TYPE_RCG, SOLVER_TYPE_MINRES,
  SOLVER_TYPE_TFQMR
}
 

Functions

bool test_single_stratimikos_solver (Teuchos::ParameterList *paramList, const bool dumpAll, Teuchos::FancyOStream *out)
 Testing function for a single stratimikos solver for a single matrix. More...
 
bool test_single_amesos_thyra_solver (const std::string matrixFile, Teuchos::ParameterList *amesosLOWSFPL, const bool testTranspose, const int numRandomVectors, const double maxFwdError, const double maxError, const double maxResid, const bool showAllTests, const bool dumpAll, Teuchos::FancyOStream *out)
 Testing function for a single amesos solver with a single matrix. More...
 
bool test_single_aztecoo_thyra_solver (const std::string matrixFile, const bool testTranspose, const int numRandomVectors, const double maxFwdError, const double maxResid, const double maxSolutionError, const bool showAllTests, const bool dumpAll, Teuchos::ParameterList *paramList, Teuchos::FancyOStream *out)
 Testing function for a single aztecoo solver with a single matrix. More...
 
std::istream & operator>> (std::istream &is, EBelosSolverType &sType)
 
bool test_single_belos_thyra_solver (const std::string matrixFile, const bool testTranspose, const bool usePreconditioner, const int numRhs, const int numRandomVectors, const double maxFwdError, const double maxResid, const double maxSolutionError, const bool showAllTests, const bool dumpAll, Teuchos::ParameterList *belosLOWSFPL, Teuchos::ParameterList *precPL, Teuchos::FancyOStream *out)
 Testing function for a single belos solver with a single matrix. More...
 
 TEUCHOS_UNIT_TEST (belos, nan_handling)
 
RCP< const LinearOpBase< double > > getFwdLinearOp ()
 
template<class Scalar >
void runGeneralSolveCriteriaBelosStatusTestCase (const SolveCriteria< Scalar > &solveCriteria, const Ptr< RCP< const VectorBase< Scalar > > > &x_out, const Ptr< RCP< const VectorBase< Scalar > > > &r_out, bool &success, FancyOStream &out)
 
 TEUCHOS_UNIT_TEST (GeneralSolveCriteriaBelosStatusTest, norm_inf_r_over_norm_inf_r0)
 
 TEUCHOS_UNIT_TEST (GeneralSolveCriteriaBelosStatusTest, norm_inf_r_over_1)
 

Variables

const std::string matrixFileName = "nos1.mtx"
 

Typedef Documentation

◆ DefaultRealLinearSolverBuilder

Definition at line 52 of file Thyra_DefaultRealLinearSolverBuilder.hpp.

Enumeration Type Documentation

◆ EBelosSolverType

Enumerator
SOLVER_TYPE_BLOCK_GMRES 
SOLVER_TYPE_PSEUDO_BLOCK_GMRES 
SOLVER_TYPE_BLOCK_CG 
SOLVER_TYPE_PSEUDO_BLOCK_CG 
SOLVER_TYPE_PSEUDO_BLOCK_STOCHASTIC_CG 
SOLVER_TYPE_GCRODR 
SOLVER_TYPE_RCG 
SOLVER_TYPE_MINRES 
SOLVER_TYPE_TFQMR 

Definition at line 56 of file Thyra_BelosLinearOpWithSolveFactory_decl.hpp.

Function Documentation

◆ test_single_amesos_thyra_solver()

bool Thyra::test_single_amesos_thyra_solver ( const std::string  matrixFile,
Teuchos::ParameterList *  amesosLOWSFPL,
const bool  testTranspose,
const int  numRandomVectors,
const double  maxFwdError,
const double  maxError,
const double  maxResid,
const bool  showAllTests,
const bool  dumpAll,
Teuchos::FancyOStream *  out 
)

Testing function for a single amesos solver with a single matrix.

Definition at line 59 of file test_single_amesos_thyra_solver.cpp.

◆ test_single_aztecoo_thyra_solver()

bool Thyra::test_single_aztecoo_thyra_solver ( const std::string  matrixFile,
const bool  testTranspose,
const int  numRandomVectors,
const double  maxFwdError,
const double  maxResid,
const double  maxSolutionError,
const bool  showAllTests,
const bool  dumpAll,
Teuchos::ParameterList *  paramList,
Teuchos::FancyOStream *  out 
)

Testing function for a single aztecoo solver with a single matrix.

Definition at line 66 of file test_single_aztecoo_thyra_solver.cpp.

◆ operator>>()

std::istream& Thyra::operator>> ( std::istream &  is,
EBelosSolverType sType 
)
inline

Definition at line 68 of file Thyra_BelosLinearOpWithSolveFactory_decl.hpp.

◆ test_single_belos_thyra_solver()

bool Thyra::test_single_belos_thyra_solver ( const std::string  matrixFile,
const bool  testTranspose,
const bool  usePreconditioner,
const int  numRhs,
const int  numRandomVectors,
const double  maxFwdError,
const double  maxResid,
const double  maxSolutionError,
const bool  showAllTests,
const bool  dumpAll,
Teuchos::ParameterList *  belosLOWSFPL,
Teuchos::ParameterList *  precPL,
Teuchos::FancyOStream *  out 
)

Testing function for a single belos solver with a single matrix.

Definition at line 65 of file test_single_belos_thyra_solver.cpp.

◆ TEUCHOS_UNIT_TEST() [1/3]

Thyra::TEUCHOS_UNIT_TEST ( belos  ,
nan_handling   
)

Definition at line 26 of file test_stratimikos_belos_nan_handler.cpp.

◆ getFwdLinearOp()

RCP<const LinearOpBase<double> > Thyra::getFwdLinearOp ( )

Definition at line 69 of file Thyra_Belos_StatusTest_UnitTests.cpp.

◆ runGeneralSolveCriteriaBelosStatusTestCase()

template<class Scalar >
void Thyra::runGeneralSolveCriteriaBelosStatusTestCase ( const SolveCriteria< Scalar > &  solveCriteria,
const Ptr< RCP< const VectorBase< Scalar > > > &  x_out,
const Ptr< RCP< const VectorBase< Scalar > > > &  r_out,
bool &  success,
FancyOStream &  out 
)

Definition at line 154 of file Thyra_Belos_StatusTest_UnitTests.cpp.

◆ TEUCHOS_UNIT_TEST() [2/3]

Thyra::TEUCHOS_UNIT_TEST ( GeneralSolveCriteriaBelosStatusTest  ,
norm_inf_r_over_norm_inf_r0   
)

Definition at line 243 of file Thyra_Belos_StatusTest_UnitTests.cpp.

◆ TEUCHOS_UNIT_TEST() [3/3]

Thyra::TEUCHOS_UNIT_TEST ( GeneralSolveCriteriaBelosStatusTest  ,
norm_inf_r_over_1   
)

Definition at line 276 of file Thyra_Belos_StatusTest_UnitTests.cpp.

Variable Documentation

◆ matrixFileName

const std::string Thyra::matrixFileName = "nos1.mtx"

Definition at line 66 of file Thyra_Belos_StatusTest_UnitTests.cpp.