Belos Package Browser (Single Doxygen Collection)  Development
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 12345]
 CBelos::BiCGStabIterationState< ScalarType, MV >Structure to contain pointers to BiCGStabIteration state variables
 Cbinary_function
 CBelos::ReorthogonalizationCallback< Scalar >Interface of callback invoked by TsqrOrthoManager on reorthogonalization
 CBelos::BlockGCRODRIterState< ScalarType, MV >Structure to contain pointers to BlockGCRODRIter state variables
 CBelos::CGIterationState< ScalarType, MV >Structure to contain pointers to CGIteration state variables
 CBelos::FixedPointIterationState< ScalarType, MV >Structure to contain pointers to FixedPointIteration state variables
 CBelos::GCRODRIterState< ScalarType, MV >Structure to contain pointers to GCRODRIter state variables
 CBelos::GmresIterationState< ScalarType, MV >Structure to contain pointers to GmresIteration state variables
 CBelos::GmresPolyOp< ScalarType, MV, OP >Belos's class for applying the GMRES polynomial operator that is used by the hybrid-GMRES linear solver
 CBelos::InnerSolver< Scalar, MV, OP >Inner solver interface
 CBelos::InnerSolveResultRepresents the result of an inner solve
 CBelos::InnerSolverTraits< Scalar, MV, OP >Wrap an InnerSolver in an OP (operator)
 CBelos::Iteration< ScalarType, MV, OP >
 CBelos::BiCGStabIter< ScalarType, MV, OP >This class implements the pseudo-block BiCGStab iteration, where the basic BiCGStab algorithm is performed on all of the linear systems simultaneously
 CBelos::BlockGCRODRIter< ScalarType, MV, OP >Implementation of the Block GCRO-DR (Block Recycling GMRES) iteration
 CBelos::CGIteration< ScalarType, MV, OP >
 CBelos::FixedPointIteration< ScalarType, MV, OP >
 CBelos::GCRODRIter< ScalarType, MV, OP >This class implements the GCRODR iteration, where a single-std::vector Krylov subspace is constructed. The QR decomposition of block, upper Hessenberg matrix is performed each iteration to update the least squares system and give the current linear system residuals
 CBelos::GmresIteration< ScalarType, MV, OP >
 CBelos::LSQRIter< ScalarType, MV, OP >Implementation of the LSQR iteration
 CBelos::MinresIteration< ScalarType, MV, OP >
 CBelos::PCPGIter< ScalarType, MV, OP >This class implements the PCPG iteration, where a single-std::vector Krylov subspace is constructed. The documentation refers to blocks, but note that at this point, all blocks have unit dimension
 CBelos::PseudoBlockGmresIter< ScalarType, MV, OP >This class implements the pseudo-block GMRES iteration, where a block Krylov subspace is constructed for all of the linear systems simultaneously.
The QR decomposition of each block, upper Hessenberg matrix is performed each iteration to update the least squares system and give the current linear system residuals
 CBelos::PseudoBlockTFQMRIter< ScalarType, MV, OP >This class implements the preconditioned transpose-free QMR algorithm for solving non-Hermitian linear systems of equations Ax = b, where b is the right-hand side vector and x is the corresponding solution
 CBelos::RCGIter< ScalarType, MV, OP >This class implements the RCG iteration, where a single-std::vector Krylov subspace is constructed
 CBelos::StochasticCGIteration< ScalarType, MV, OP >
 CBelos::TFQMRIter< ScalarType, MV, OP >This class implements the preconditioned transpose-free QMR algorithm for solving non-Hermitian linear systems of equations Ax = b, where b is the right-hand side vector and x is the corresponding solution
 C
 C
 CBelos::Details::LapackSupportsScalar< ScalarType >Type traits class that says whether Teuchos::LAPACK has a valid implementation for the given ScalarType
 CBelos::Details::LapackSupportsScalar< double >
 CBelos::Details::LapackSupportsScalar< float >
 CBelos::LinearProblem< ScalarType, MV, OP >A linear system to solve, and its associated information
 C
 CBelos::Details::LinearSolver< MV, OP, ScalarType, NormType >Belos' implementation of Trilinos::Details::LinearSolver
 C
 CBelos::Details::LinearSolverFactory< MV, OP, ScalarType, NormType >
 CBelos::details::LocalDenseMatrixOps< Scalar >Low-level operations on non-distributed dense matrices
 Clogic_error
 CBelos::BelosErrorParent class to all Belos exceptions
 CBelos::LSQRIterationState< ScalarType, MV >Structure to contain pointers to LSQRIteration state variables, ..
 CLSQRStatusTestA Belos::StatusTest class for specifying convergence of LSQR. The outer status tests passes if an inner status passes a user specified number of times consecutively. The inner status test depends on information specific to LSQR iteration
 CBelos::MinresIterationState< ScalarType, MV >Structure to contain pointers to MinresIteration state variables
 CBelos::MultiVec< ScalarType >Interface for multivectors used by Belos' linear solvers
 CMyMultiVec< ScalarType >Simple example of a user's defined Belos::MultiVec class
 CBelos::MultiVecTraits< ScalarType, MV >Traits class which defines basic operations on multivectors
 CBelos::MultiVecTraits< ScalarType, MultiVec< ScalarType > >Specialization of MultiVecTraits for Belos::MultiVec
 CBelos::details::MultiVecTsqrAdapter< ScalarType >TSQR adapter for MultiVec
 CBelos::Operator< ScalarType >Alternative run-time polymorphic interface for operators
 CMyBetterOperator< ScalarType >Simple example of a user's defined Belos::Operator class
 CMyOperator< ScalarType >Simple example of a user's defined Belos::Operator class
 CBelos::OperatorTraits< ScalarType, MV, OP >Class which defines basic traits for the operator type
 CBelos::OperatorTraits< Scalar, MV, InnerSolver< Scalar, MV, OP > >Partial specialization of OperatorTraits for InnerSolver
 CBelos::OperatorTraits< ScalarType, MultiVec< ScalarType >, Operator< ScalarType > >Specialization of OperatorTraits for Operator and MultiVec
 CBelos::OperatorTraits< ScalarType, MV, GmresPolyOp< ScalarType, MV, OP > >Template specialization of Belos::OperatorTraits class using Belos::GmresPolyOp
 CBelos::OrthoManager< ScalarType, MV >Belos's templated virtual class for providing routines for orthogonalization and orthonormzalition of multivectors
 CBelos::MatOrthoManager< ScalarType, MV, OP >Belos's templated virtual class for providing routines for orthogonalization and orthonormzalition of multivectors using matrix-based inner products
 CBelos::OrthoManager< Scalar, MV >
 CBelos::SimpleOrthoManager< Scalar, MV >Simple OrthoManager implementation for benchmarks
 CBelos::TsqrOrthoManager< Scalar, MV >TSQR-based OrthoManager subclass
 CBelos::MatOrthoManager< Scalar, MV, OP >
 CBelos::Test::OrthoManagerBenchmarker< Scalar, MV >OrthoManager benchmark
 CBelos::OrthoManagerFactory< Scalar, MV, OP >Enumeration of all valid Belos (Mat)OrthoManager classes
 CBelos::OrthoManagerFactory< ScalarType, MV, OP >
 CBelos::Test::OrthoManagerTester< Scalar, MV >Wrapper around OrthoManager test functionality
 CBelos::OutOfPlaceNormalizerMixin< Scalar, MV >Mixin for out-of-place orthogonalization
 CBelos::TsqrMatOrthoManager< Scalar, MV, OP >MatOrthoManager subclass using TSQR or DGKS
 CBelos::TsqrOrthoManager< Scalar, MV >TSQR-based OrthoManager subclass
 CBelos::OutputManager< ScalarType >Belos's basic output manager for sending information of select verbosity levels to the appropriate output stream
 CBelos::OutputManager< Scalar >
 C
 CBelos::TsqrOrthoManager< Scalar, MV >TSQR-based OrthoManager subclass
 C
 CBelos::PCPGIterState< ScalarType, MV >Structure to contain pointers to PCPGIter state variables
 CBelos::details::ProjectedLeastSquaresProblem< Scalar >"Container" for the GMRES projected least-squares problem
 CBelos::details::ProjectedLeastSquaresSolver< Scalar >Methods for solving GMRES' projected least-squares problem
 CBelos::PseudoBlockGmresIterState< ScalarType, MV >Structure to contain pointers to PseudoBlockGmresIter state variables
 CBelos::PseudoBlockTFQMRIterState< ScalarType, MV >Structure to contain pointers to PseudoBlockTFQMRIter state variables
 CBelos::RCGIterState< ScalarType, MV >Structure to contain pointers to RCGIter state variables
 CBelos::Details::RealSolverManager< ScalarType, MV, OP, isComplex >Base class for Belos::SolverManager subclasses which normally can only compile for real ScalarType
 CBelos::Details::RealSolverManager< ScalarType, MV, OP, Teuchos::ScalarTraits< ScalarType >::isComplex >
 CBelos::LSQRSolMgr< ScalarType, MV, OP, scalarTypeIsComplex >LSQR method (for linear systems and linear least-squares problems)
 CBelos::Details::SolverManagerRequiresLapack< ScalarType, MV, OP, lapackSupportsScalarType >Base class for Belos::SolverManager subclasses which normally can only compile with ScalarType types for which Teuchos::LAPACK has a valid implementation
 CBelos::Details::SolverManagerRequiresLapack< ScalarType, MV, OP >
 CBelos::BlockCGSolMgr< ScalarType, MV, OP, lapackSupportsScalarType >The Belos::BlockCGSolMgr provides a powerful and fully-featured solver manager over the CG and BlockCG linear solver
 CBelos::GCRODRSolMgr< ScalarType, MV, OP, lapackSupportsScalarType >Implementation of the GCRODR (Recycling GMRES) iterative linear solver
 CBelos::Details::SolverManagerRequiresLapack< ScalarType, MV, OP, Belos::Details::LapackSupportsScalar< ScalarType >::value >
 CBelos::PseudoBlockCGSolMgr< ScalarType, MV, OP, supportsScalarType >The Belos::PseudoBlockCGSolMgr provides a powerful and fully-featured solver manager over the pseudo-block CG iteration
 CBelos::Details::SolverManagerRequiresRealLapack< ScalarType, MV, OP, supportsScalarType >Base class for Belos::SolverManager subclasses which normally can only compile with real ScalarType types for which Teuchos::LAPACK has a valid implementation
 CBelos::Details::SolverManagerRequiresRealLapack< ScalarType, MV, OP, Belos::Details::LapackSupportsScalar< ScalarType >::value &&! Teuchos::ScalarTraits< ScalarType >::isComplex >
 CBelos::PCPGSolMgr< ScalarType, MV, OP, supportsScalarType >PCPG iterative linear solver
 CBelos::RCGSolMgr< ScalarType, MV, OP, supportsScalarType >Implementation of the RCG (Recycling Conjugate Gradient) iterative linear solver
 CBelos::StatusTestFactory< Scalar, MV, OP >Factory to build a set of status tests from a parameter list
 CBelos::StatusTestOutputFactory< ScalarType, MV, OP >A factory class for generating StatusTestOutput objects
 CBelos::StochasticCGIterationState< ScalarType, MV >Structure to contain pointers to CGIteration state variables
 CBelos::TFQMRIterState< ScalarType, MV >Structure to contain pointers to TFQMRIter state variables
 CBelos::UndefinedMultiVecTraits< ScalarType, MV >Used by MultiVecTraits to report lack of a specialization
 CBelos::UndefinedOperatorTraits< ScalarType, MV, OP >Class used to require specialization of OperatorTraits
 CBelos::UndefinedWrapperType< Scalar, MV, OP >Undefined wrapper type, to check at compile time whether InnerSolverTraits has been specialized