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

Generated for Belos by doxygen 1.10.0