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

Namespaces

namespace  Amesos
 
namespace  Amesos2
 

Classes

class  Amesos2LinearOpWithSolve
 Concrete LinearOpWithSolveBase subclass in terms of Amesos2. More...
 
class  Amesos2LinearOpWithSolveFactory
 
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  BelosTpetraGmres
 
class  BelosTpetraGmresPipeline
 
class  BelosTpetraGmresSingleReduce
 
class  BelosTpetraGmresSstep
 
class  BelosTpetraKrylov
 
class  BelosTpetraPreconditionerFactory
 Concrete preconditioner factory subclass based on Belos. (Yes, Belos solvers can also be used as preconditioners!) 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 , SOLVER_TYPE_BICGSTAB , SOLVER_TYPE_FIXEDPOINT , SOLVER_TYPE_TPETRA_GMRES ,
  SOLVER_TYPE_TPETRA_GMRES_PIPELINE , SOLVER_TYPE_TPETRA_GMRES_SINGLE_REDUCE , SOLVER_TYPE_TPETRA_GMRES_SSTEP
}
 

Functions

bool test_epetra_stratimikos_solver (Teuchos::ParameterList *paramList, const bool dumpAll, Teuchos::FancyOStream *out)
 Testing function for a single epetra stratimikos solver for a single matrix.
 
bool test_tpetra_stratimikos_solver (Teuchos::ParameterList *paramList, const bool dumpAll, Teuchos::FancyOStream *out)
 Testing function for a single tpetra stratimikos solver for a single matrix.
 
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.
 
bool test_single_amesos2_tpetra_solver (const std::string matrixFile, const int numRhs, const int numRandomVectors, const double maxFwdError, const double maxResid, const double maxSolutionError, const bool showAllTests, const bool dumpAll, Teuchos::ParameterList *amesos2LOWSFPL, Teuchos::FancyOStream *out, const Teuchos::RCP< const Teuchos::Comm< int > > &comm)
 Testing function for a single belos solver with a single matrix.
 
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.
 
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.
 
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 
SOLVER_TYPE_BICGSTAB 
SOLVER_TYPE_FIXEDPOINT 
SOLVER_TYPE_TPETRA_GMRES 
SOLVER_TYPE_TPETRA_GMRES_PIPELINE 
SOLVER_TYPE_TPETRA_GMRES_SINGLE_REDUCE 
SOLVER_TYPE_TPETRA_GMRES_SSTEP 

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 63 of file test_single_amesos_thyra_solver.cpp.

◆ test_single_amesos2_tpetra_solver()

bool Thyra::test_single_amesos2_tpetra_solver ( const std::string matrixFile,
const int numRhs,
const int numRandomVectors,
const double maxFwdError,
const double maxResid,
const double maxSolutionError,
const bool showAllTests,
const bool dumpAll,
Teuchos::ParameterList * amesos2LOWSFPL,
Teuchos::FancyOStream * out,
const Teuchos::RCP< const Teuchos::Comm< int > > & comm )

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

Definition at line 58 of file test_single_amesos2_tpetra_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 74 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.

◆ 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() [1/2]

Thyra::TEUCHOS_UNIT_TEST ( GeneralSolveCriteriaBelosStatusTest ,
norm_inf_r_over_norm_inf_r0  )

Definition at line 242 of file Thyra_Belos_StatusTest_UnitTests.cpp.

◆ TEUCHOS_UNIT_TEST() [2/2]

Thyra::TEUCHOS_UNIT_TEST ( GeneralSolveCriteriaBelosStatusTest ,
norm_inf_r_over_1  )

Definition at line 275 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.