Belos Package Browser (Single Doxygen Collection) Development
Loading...
Searching...
No Matches
src Directory Reference

Files

 Belos_Details_EBelosSolverType.cpp
 
 Belos_Details_EBelosSolverType.hpp
 Declaration of alias functions for solver names.
 
 Belos_Details_LinearSolver.hpp
 Implementation of Trilinos::Details::LinearSolver.
 
 Belos_Details_LinearSolverFactory.hpp
 Implementation of Trilinos::Details::LinearSolverFactory.
 
 Belos_Details_registerLinearSolverFactory.cpp
 
 Belos_Details_registerLinearSolverFactory.hpp
 Declaration of Belos::Details::registerLinearSolverFactory.
 
 Belos_Details_registerSolverFactory.cpp
 
 Belos_Details_registerSolverFactory.hpp
 
 BelosBiCGStabIter.hpp
 Belos concrete class for performing the pseudo-block BiCGStab iteration.
 
 BelosBiCGStabSolMgr.hpp
 The Belos::BiCGStabSolMgr provides a solver manager for the BiCGStab linear solver.
 
 BelosBlockCGIter.hpp
 Belos concrete class for performing the block conjugate-gradient (CG) iteration.
 
 BelosBlockCGSolMgr.hpp
 The Belos::BlockCGSolMgr provides a solver manager for the BlockCG linear solver.
 
 BelosBlockFGmresIter.hpp
 Belos concrete class for performing the block, flexible GMRES iteration.
 
 BelosBlockGCRODRIter.hpp
 Belos concrete class for performing the block GCRO-DR (block GMRES with recycling) iteration.
 
 BelosBlockGCRODRSolMgr.hpp
 A solver manager for the Block GCRO-DR (Block Recycling GMRES) linear solver.
 
 BelosBlockGmresIter.hpp
 Belos concrete class for performing the block GMRES iteration.
 
 BelosBlockGmresSolMgr.hpp
 The Belos::BlockGmresSolMgr provides a solver manager for the BlockGmres linear solver.
 
 BelosCGIter.hpp
 Belos concrete class for performing the conjugate-gradient (CG) iteration.
 
 BelosCGIteration.hpp
 Pure virtual base class which augments the basic interface for a conjugate gradient linear solver iteration.
 
 BelosCGSingleRedIter.hpp
 Belos concrete class for performing a single-reduction conjugate-gradient (CG) iteration.
 
 BelosConfigDefs.hpp
 Belos header file which uses auto-configuration information to include necessary C++ headers.
 
 BelosCustomSolverFactory.hpp
 
 BelosDGKSOrthoManager.hpp
 Classical Gram-Schmidt (with DGKS correction) implementation of the Belos::OrthoManager class.
 
 BelosFixedPointIter.hpp
 Belos concrete class for performing fixed point iteration iteration.
 
 BelosFixedPointIteration.hpp
 Pure virtual base class which augments the basic interface for a fixed point linear solver iteration.
 
 BelosFixedPointSolMgr.hpp
 The Belos::FixedPointSolMgr provides a solver manager for the FixedPoint linear solver.
 
 BelosGCRODRIter.hpp
 Belos concrete class for performing the GCRO-DR iteration.
 
 BelosGCRODRSolMgr.hpp
 Declaration and definition of Belos::GCRODRSolMgr, which implements the GCRODR (recycling GMRES) solver.
 
 BelosGmresIteration.hpp
 Pure virtual base class which augments the basic interface for a Gmres linear solver iteration.
 
 BelosGmresPolyOp.hpp
 Defines the GMRES polynomial operator hybrid-GMRES iterative linear solver.
 
 BelosGmresPolySolMgr.hpp
 Declaration and definition of Belos::GmresPolySolMgr (hybrid block GMRES linear solver).
 
 BelosICGSOrthoManager.hpp
 Iterated Classical Gram-Schmidt (ICGS) implementation of the Belos::OrthoManager class.
 
 BelosIMGSOrthoManager.hpp
 Iterated Modified Gram-Schmidt (IMGS) implementation of the Belos::OrthoManager class.
 
 BelosInnerSolver.hpp
 
 BelosInnerSolveResult.cpp
 
 BelosInnerSolveResult.hpp
 
 BelosIteration.hpp
 Pure virtual base class which describes the basic interface to the linear solver iteration.
 
 BelosLinearProblem.hpp
 Class which describes the linear problem to be solved by the iterative solver.
 
 BelosLSQRIter.hpp
 Belos concrete class that iterates LSQR.
 
 BelosLSQRIteration.hpp
 IterationState contains the data that defines the state of the LSQR solver at any given time.
 
 BelosLSQRSolMgr.hpp
 LSQRSolMgr: interface to the LSQR method.
 
 BelosLSQRStatusTest.hpp
 Belos::StatusTest class defining LSQR convergence.
 
 BelosMatOrthoManager.hpp
 Templated virtual class for providing orthogonalization/orthonormalization methods with matrix-based inner products.
 
 BelosMinresIter.hpp
 MINRES iteration implementation.
 
 BelosMinresIteration.hpp
 Pure virtual base class which augments the basic interface for a minimal residual linear solver iteration.
 
 BelosMinresSolMgr.hpp
 Solver manager for the MINRES linear solver.
 
 BelosMultiVec.hpp
 Interface for multivectors used by Belos' linear solvers.
 
 BelosMultiVecTraits.hpp
 Declaration of basic traits for the multivector type.
 
 BelosMVOPTester.hpp
 Test routines for MultiVecTraits and OperatorTraits conformity.
 
 BelosOperator.hpp
 Alternative run-time polymorphic interface for operators.
 
 BelosOperatorT.hpp
 
 BelosOperatorTraits.hpp
 Class which defines basic traits for the operator type.
 
 BelosOrthoManager.hpp
 Templated virtual class for providing orthogonalization/orthonormalization methods.
 
 BelosOrthoManagerFactory.hpp
 
 BelosOrthoManagerTest.hpp
 Tests for Belos::OrthoManager and Belos::MatOrthoManager subclasses.
 
 BelosOutputManager.hpp
 Class which manages the output and verbosity of the Belos solvers.
 
 BelosPCPGIter.hpp
 Belos concrete class to iterate Preconditioned Conjugate Projected Gradients.
 
 BelosPCPGSolMgr.hpp
 Declaration and definition of Belos::PCPGSolMgr (PCPG iterative linear solver).
 
 BelosProjectedLeastSquaresSolver.hpp
 Methods for solving GMRES' projected least-squares problem.
 
 BelosPseudoBlockCGIter.hpp
 Belos concrete class for performing the pseudo-block CG iteration.
 
 BelosPseudoBlockCGSolMgr.hpp
 The Belos::PseudoBlockCGSolMgr provides a solver manager for the BlockCG linear solver.
 
 BelosPseudoBlockGmresIter.hpp
 Belos concrete class for performing the pseudo-block GMRES iteration.
 
 BelosPseudoBlockGmresSolMgr.hpp
 The Belos::PseudoBlockGmresSolMgr provides a solver manager for the BlockGmres linear solver.
 
 BelosPseudoBlockStochasticCGIter.hpp
 Belos concrete class for performing the stochastic pseudo-block CG iteration.
 
 BelosPseudoBlockStochasticCGSolMgr.hpp
 The Belos::PseudoBlockStochasticCGSolMgr provides a solver manager for the stochastic BlockCG linear solver.
 
 BelosPseudoBlockTFQMRIter.hpp
 Belos concrete class for generating iterations with the preconditioned tranpose-free QMR (TFQMR) method.
 
 BelosPseudoBlockTFQMRSolMgr.hpp
 The Belos::PseudoBlockTFQMRSolMgr provides a solver manager for the pseudo-block TFQMR linear solver.
 
 BelosRCGIter.hpp
 Belos concrete class for performing the RCG iteration.
 
 BelosRCGSolMgr.hpp
 The Belos::RCGSolMgr provides a solver manager for the RCG (Recycling Conjugate Gradient) linear solver.
 
 BelosSimpleOrthoManager.hpp
 Simple OrthoManager implementation for benchmarks.
 
 BelosSolverFactory.cpp
 
 BelosSolverFactory.hpp
 
 BelosSolverFactory_Belos.hpp
 
 BelosSolverFactory_Generic.hpp
 
 BelosSolverManager.hpp
 Pure virtual base class which describes the basic interface for a solver manager.
 
 BelosStatusTest.hpp
 Pure virtual base class for defining the status testing capabilities of Belos.
 
 BelosStatusTestCombo.hpp
 Belos::StatusTest for logically combining several status tests.
 
 BelosStatusTestFactory.hpp
 
 BelosStatusTestGeneralOutput.hpp
 Special StatusTest for printing any kind of status test.
 
 BelosStatusTestGenResNorm.hpp
 Belos::StatusTestResNorm for specifying general residual norm stopping criteria.
 
 BelosStatusTestGenResSubNorm.hpp
 Belos::StatusTestResSubNorm for specifying general residual norm of sub-residual vectors stopping criteria.
 
 BelosStatusTestImpResNorm.hpp
 Belos::StatusTest for specifying an implicit residual norm stopping criteria that checks for loss of accuracy.
 
 BelosStatusTestLogResNorm.hpp
 Belos::StatusTest debugging class for storing the absolute residual norms generated during a solve.
 
 BelosStatusTestMaxIters.hpp
 Belos::StatusTest class for specifying a maximum number of iterations.
 
 BelosStatusTestOutput.hpp
 Virtual base class for StatusTest that printing status tests.
 
 BelosStatusTestOutputFactory.hpp
 A factory class for generating StatusTestOutput objects.
 
 BelosStatusTestResNorm.hpp
 Belos::StatusTest abstract class for specifying a residual norm stopping criteria.
 
 BelosStatusTestResNormOutput.hpp
 Special StatusTest for printing status tests in simple format for residuals.
 
 BelosStatusTestUserOutput.hpp
 Special StatusTest for printing status tests in simple format for residuals.
 
 BelosStochasticCGIteration.hpp
 Pure virtual base class which augments the basic interface for a stochastic conjugate gradient linear solver iteration.
 
 BelosStubTsqrAdapter.hpp
 "Stub" TSQR adapter for unsupported multivector types.
 
 BelosTFQMRIter.hpp
 Belos concrete class for generating iterations with the preconditioned tranpose-free QMR (TFQMR) method.
 
 BelosTFQMRSolMgr.hpp
 The Belos::TFQMRSolMgr provides a solver manager for the TFQMR linear solver.
 
 BelosTsqrOrthoManager.hpp
 Orthogonalization manager based on Tall Skinny QR (TSQR)
 
 BelosTsqrOrthoManagerImpl.hpp
 Orthogonalization manager back end based on Tall Skinny QR (TSQR)
 
 BelosTypes.cpp
 
 BelosTypes.hpp
 Collection of types and exceptions used within the Belos solvers.
 
 BelosUtils.hpp
 
 BelosVersion.cpp
 Simple function for returning the current version number [necessary for portability].