| Stratimikos Package Browser (Single Doxygen Collection)
    Version of the Day
    | 
| Namespaces | |
| Amesos | |
| Amesos2 | |
| Classes | |
| class | AmesosLinearOpWithSolve | 
| Concrete LinearOpWithSolveBasesubclass that adapts anyAmesos_BaseSolverobject.  More... | |
| class | AmesosLinearOpWithSolveFactory | 
| Concrete LinearOpWithSolveFactoryBaseadapter subclass that uses Amesos direct solvers.  More... | |
| class | Amesos2LinearOpWithSolve | 
| Concrete LinearOpWithSolveBasesubclass in terms ofAmesos2.  More... | |
| class | Amesos2LinearOpWithSolveFactory | 
| class | AztecOOLinearOpWithSolve | 
| Concrete LinearOpWithSolveBasesubclass implemented usingAztecOO.  More... | |
| class | AztecOOLinearOpWithSolveFactory | 
| LinearOpWithSolveFactoryBasesubclass implemented in terms ofAztecOO.  More... | |
| class | BelosLinearOpWithSolve | 
| Concrete LinearOpWithSolveBasesubclass in terms ofBelos.  More... | |
| class | BelosLinearOpWithSolveFactory | 
| LinearOpWithSolveFactoryBasesubclass implemented in terms ofBelos.  More... | |
| class | GeneralSolveCriteriaBelosStatusTest | 
| Subclass of Belos::StatusTest that implements every possible form of SolveCriteria that exists by forcing the computation of XandR.  More... | |
| class | TsqrAdaptor | 
| Stub adaptor from Thyra::MultiVectorBase to TSQR.  More... | |
| class | MockNormInfReductionFunctional | 
| Mock NormInf ReductionFunctional subclass used for unit testing.  More... | |
| class | MockMaxNormInfEpsReductionFunctional | 
| Mock max(NormInf, eps) ReductionFunctional subclass used for unit testing.  More... | |
| class | IfpackPreconditionerFactory | 
| Concrete preconditioner factory subclass based on Ifpack.  More... | |
| class | MLPreconditionerFactory | 
| Concrete preconditioner factory subclass based on ML.  More... | |
| Typedefs | |
| typedef Stratimikos::DefaultLinearSolverBuilder | DefaultRealLinearSolverBuilder | 
| 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_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.  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... | |
| 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" | 
Definition at line 52 of file Thyra_DefaultRealLinearSolverBuilder.hpp.
Definition at line 56 of file Thyra_BelosLinearOpWithSolveFactory_decl.hpp.
| 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.
| 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.
| 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.
| 
 | inline | 
Definition at line 68 of file Thyra_BelosLinearOpWithSolveFactory_decl.hpp.
| 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.
| RCP<const LinearOpBase<double> > Thyra::getFwdLinearOp | ( | ) | 
Definition at line 69 of file Thyra_Belos_StatusTest_UnitTests.cpp.
| 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.
| Thyra::TEUCHOS_UNIT_TEST | ( | GeneralSolveCriteriaBelosStatusTest | , | 
| norm_inf_r_over_norm_inf_r0 | |||
| ) | 
Definition at line 243 of file Thyra_Belos_StatusTest_UnitTests.cpp.
| Thyra::TEUCHOS_UNIT_TEST | ( | GeneralSolveCriteriaBelosStatusTest | , | 
| norm_inf_r_over_1 | |||
| ) | 
Definition at line 276 of file Thyra_Belos_StatusTest_UnitTests.cpp.
| const std::string Thyra::matrixFileName = "nos1.mtx" | 
Definition at line 66 of file Thyra_Belos_StatusTest_UnitTests.cpp.
 1.8.5
 1.8.5