Belos Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
File List
Here is a list of all files with brief descriptions:
o*Aztec_to_Belos_param.cpp
o*Belos_Details_EBelosSolverType.cpp
o*Belos_Details_EBelosSolverType.hppDeclaration of alias functions for solver names
o*Belos_Details_LinearSolver.hppImplementation of Trilinos::Details::LinearSolver
o*Belos_Details_LinearSolverFactory.hppImplementation of Trilinos::Details::LinearSolverFactory
o*Belos_Details_registerLinearSolverFactory.cpp
o*Belos_Details_registerLinearSolverFactory.hppDeclaration of Belos::Details::registerLinearSolverFactory
o*Belos_Details_registerSolverFactory.cpp
o*Belos_Details_registerSolverFactory.hpp
o*BelosBiCGStabIter.hppBelos concrete class for performing the pseudo-block BiCGStab iteration
o*BelosBiCGStabSolMgr.hppThe Belos::BiCGStabSolMgr provides a solver manager for the BiCGStab linear solver
o*BelosBlockCGIter.hppBelos concrete class for performing the block conjugate-gradient (CG) iteration
o*BelosBlockCGSolMgr.hppThe Belos::BlockCGSolMgr provides a solver manager for the BlockCG linear solver
o*BelosBlockFGmresIter.hppBelos concrete class for performing the block, flexible GMRES iteration
o*BelosBlockGCRODRIter.hppBelos concrete class for performing the block GCRO-DR (block GMRES with recycling) iteration
o*BelosBlockGCRODRSolMgr.hppA solver manager for the Block GCRO-DR (Block Recycling GMRES) linear solver
o*BelosBlockGmresIter.hppBelos concrete class for performing the block GMRES iteration
o*BelosBlockGmresSolMgr.hppThe Belos::BlockGmresSolMgr provides a solver manager for the BlockGmres linear solver
o*BelosCGIter.hppBelos concrete class for performing the conjugate-gradient (CG) iteration
o*BelosCGIteration.hppPure virtual base class which augments the basic interface for a conjugate gradient linear solver iteration
o*BelosCGSingleRedIter.hppBelos concrete class for performing a single-reduction conjugate-gradient (CG) iteration
o*BelosConfigDefs.hppBelos header file which uses auto-configuration information to include necessary C++ headers
o*BelosCustomSolverFactory.hpp
o*BelosDGKSOrthoManager.hppClassical Gram-Schmidt (with DGKS correction) implementation of the Belos::OrthoManager class
o*BelosFixedPointIter.hppBelos concrete class for performing fixed point iteration iteration
o*BelosFixedPointIteration.hppPure virtual base class which augments the basic interface for a fixed point linear solver iteration
o*BelosFixedPointSolMgr.hppThe Belos::FixedPointSolMgr provides a solver manager for the FixedPoint linear solver
o*BelosGCRODRIter.hppBelos concrete class for performing the GCRO-DR iteration
o*BelosGCRODRSolMgr.hppDeclaration and definition of Belos::GCRODRSolMgr, which implements the GCRODR (recycling GMRES) solver
o*BelosGlobalComm.hpp
o*BelosGmresIteration.hppPure virtual base class which augments the basic interface for a Gmres linear solver iteration
o*BelosGmresPolyOp.hppDefines the GMRES polynomial operator hybrid-GMRES iterative linear solver
o*BelosGmresPolySolMgr.hppDeclaration and definition of Belos::GmresPolySolMgr (hybrid block GMRES linear solver)
o*BelosICGSOrthoManager.hppIterated Classical Gram-Schmidt (ICGS) implementation of the Belos::OrthoManager class
o*BelosIMGSOrthoManager.hppIterated Modified Gram-Schmidt (IMGS) implementation of the Belos::OrthoManager class
o*BelosInnerSolver.hpp
o*BelosInnerSolveResult.cpp
o*BelosInnerSolveResult.hpp
o*BelosIteration.hppPure virtual base class which describes the basic interface to the linear solver iteration
o*BelosLinearProblem.hppClass which describes the linear problem to be solved by the iterative solver
o*BelosLSQRIter.hppBelos concrete class that iterates LSQR
o*BelosLSQRIteration.hppIterationState contains the data that defines the state of the LSQR solver at any given time
o*BelosLSQRSolMgr.hppLSQRSolMgr: interface to the LSQR method
o*BelosLSQRStatusTest.hppBelos::StatusTest class defining LSQR convergence
o*BelosMatOrthoManager.hppTemplated virtual class for providing orthogonalization/orthonormalization methods with matrix-based inner products
o*BelosMinresIter.hppMINRES iteration implementation
o*BelosMinresIteration.hppPure virtual base class which augments the basic interface for a minimal residual linear solver iteration
o*BelosMinresSolMgr.hppSolver manager for the MINRES linear solver
o*BelosMultiVec.hppInterface for multivectors used by Belos' linear solvers
o*BelosMultiVecTraits.hppDeclaration of basic traits for the multivector type
o*BelosMVOPTester.hppTest routines for MultiVecTraits and OperatorTraits conformity
o*BelosOperator.hppAlternative run-time polymorphic interface for operators
o*BelosOperatorT.hpp
o*BelosOperatorTraits.hppClass which defines basic traits for the operator type
o*BelosOrthoManager.hppTemplated virtual class for providing orthogonalization/orthonormalization methods
o*BelosOrthoManagerFactory.hpp
o*BelosOrthoManagerTest.hppTests for Belos::OrthoManager and Belos::MatOrthoManager subclasses
o*BelosOutputManager.hppClass which manages the output and verbosity of the Belos solvers
o*BelosPCPGIter.hppBelos concrete class to iterate Preconditioned Conjugate Projected Gradients
o*BelosPCPGSolMgr.hppDeclaration and definition of Belos::PCPGSolMgr (PCPG iterative linear solver)
o*BelosProjectedLeastSquaresSolver.hppMethods for solving GMRES' projected least-squares problem
o*BelosPseudoBlockCGIter.hppBelos concrete class for performing the pseudo-block CG iteration
o*BelosPseudoBlockCGSolMgr.hppThe Belos::PseudoBlockCGSolMgr provides a solver manager for the BlockCG linear solver
o*BelosPseudoBlockGmresIter.hppBelos concrete class for performing the pseudo-block GMRES iteration
o*BelosPseudoBlockGmresSolMgr.hppThe Belos::PseudoBlockGmresSolMgr provides a solver manager for the BlockGmres linear solver
o*BelosPseudoBlockStochasticCGIter.hppBelos concrete class for performing the stochastic pseudo-block CG iteration
o*BelosPseudoBlockStochasticCGSolMgr.hppThe Belos::PseudoBlockStochasticCGSolMgr provides a solver manager for the stochastic BlockCG linear solver
o*BelosPseudoBlockTFQMRIter.hppBelos concrete class for generating iterations with the preconditioned tranpose-free QMR (TFQMR) method
o*BelosPseudoBlockTFQMRSolMgr.hppThe Belos::PseudoBlockTFQMRSolMgr provides a solver manager for the pseudo-block TFQMR linear solver
o*BelosRCGIter.hppBelos concrete class for performing the RCG iteration
o*BelosRCGSolMgr.hppThe Belos::RCGSolMgr provides a solver manager for the RCG (Recycling Conjugate Gradient) linear solver
o*BelosSimpleOrthoManager.hppSimple OrthoManager implementation for benchmarks
o*BelosSolverFactory.cpp
o*BelosSolverFactory.hpp
o*BelosSolverFactory_Belos.hpp
o*BelosSolverFactory_Generic.hpp
o*BelosSolverManager.hppPure virtual base class which describes the basic interface for a solver manager
o*BelosStatusTest.hppPure virtual base class for defining the status testing capabilities of Belos
o*BelosStatusTestCombo.hppBelos::StatusTest for logically combining several status tests
o*BelosStatusTestFactory.hpp
o*BelosStatusTestGeneralOutput.hppSpecial StatusTest for printing any kind of status test
o*BelosStatusTestGenResNorm.hppBelos::StatusTestResNorm for specifying general residual norm stopping criteria
o*BelosStatusTestGenResSubNorm.hppBelos::StatusTestResSubNorm for specifying general residual norm of sub-residual vectors stopping criteria
o*BelosStatusTestImpResNorm.hppBelos::StatusTest for specifying an implicit residual norm stopping criteria that checks for loss of accuracy
o*BelosStatusTestLogResNorm.hppBelos::StatusTest debugging class for storing the absolute residual norms generated during a solve
o*BelosStatusTestMaxIters.hppBelos::StatusTest class for specifying a maximum number of iterations
o*BelosStatusTestOutput.hppVirtual base class for StatusTest that printing status tests
o*BelosStatusTestOutputFactory.hppA factory class for generating StatusTestOutput objects
o*BelosStatusTestResNorm.hppBelos::StatusTest abstract class for specifying a residual norm stopping criteria
o*BelosStatusTestResNormOutput.hppSpecial StatusTest for printing status tests in simple format for residuals
o*BelosStatusTestUserOutput.hppSpecial StatusTest for printing status tests in simple format for residuals
o*BelosStochasticCGIteration.hppPure virtual base class which augments the basic interface for a stochastic conjugate gradient linear solver iteration
o*BelosStubTsqrAdapter.hpp"Stub" TSQR adapter for unsupported multivector types
o*BelosTFQMRIter.hppBelos concrete class for generating iterations with the preconditioned tranpose-free QMR (TFQMR) method
o*BelosTFQMRSolMgr.hppThe Belos::TFQMRSolMgr provides a solver manager for the TFQMR linear solver
o*BelosTsqrOrthoManager.hppOrthogonalization manager based on Tall Skinny QR (TSQR)
o*BelosTsqrOrthoManagerImpl.hppOrthogonalization manager back end based on Tall Skinny QR (TSQR)
o*BelosTypes.cpp
o*BelosTypes.hppCollection of types and exceptions used within the Belos solvers
o*BelosUtils.hpp
o*BelosVersion.cppSimple function for returning the current version number [necessary for portability]
o*cxx_main_complex.cpp
o*Factory.cpp
o*MyBetterOperator.hpp
o*MyMultiVec.hpp
o*MyOperator.hpp
o*test_belos_projected_least_squares_solver.cpp
o*test_bl_cg_complex_hb.cpp
o*test_bl_cg_real_hb.cpp
o*test_bl_gmres_complex_diag.cpp
o*test_bl_gmres_complex_hb.cpp
o*test_factory_complex.cpp
o*test_gcrodr_complex.cpp
o*test_gcrodr_complex_hb.cpp
o*test_hybrid_gmres_complex_hb.cpp
o*test_lsqr_complex.cpp
o*test_minres_complex_hb.cpp
o*test_pseudo_tfqmr_complex_hb.cpp
o*test_rcg_complex.cpp
o*test_tfqmr_complex_diag.cpp
\*test_tfqmr_complex_hb.cpp