Belos::BiCGStabIterationState< ScalarType, MV > | Structure to contain pointers to BiCGStabIteration state variables |
binary_function | |
Belos::ReorthogonalizationCallback< Scalar > | Interface of callback invoked by TsqrOrthoManager on reorthogonalization |
Belos::BlockGCRODRIterState< ScalarType, MV > | Structure to contain pointers to BlockGCRODRIter state variables |
Belos::CGIterationState< ScalarType, MV > | Structure to contain pointers to CGIteration state variables |
Belos::CustomSolverFactory< Scalar, MV, OP > | Interface for custom Belos solver factories |
Belos::DefaultSolverParameters | Default parameters common to most Belos solvers |
Belos::FixedPointIterationState< ScalarType, MV > | Structure to contain pointers to FixedPointIteration state variables |
Belos::GCRODRIterState< ScalarType, MV > | Structure to contain pointers to GCRODRIter state variables |
Belos::GmresIterationState< ScalarType, MV > | Structure to contain pointers to GmresIteration state variables |
Belos::InnerSolver< Scalar, MV, OP > | Inner solver interface |
Belos::InnerSolveResult | Represents the result of an inner solve |
Belos::InnerSolverTraits< Scalar, MV, OP > | Wrap an InnerSolver in an OP (operator) |
Belos::Iteration< ScalarType, MV, OP > | |
Belos::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 |
Belos::BlockGCRODRIter< ScalarType, MV, OP > | Implementation of the Block GCRO-DR (Block Recycling GMRES) iteration |
Belos::CGIteration< ScalarType, MV, OP > | |
Belos::BlockCGIter< ScalarType, MV, OP, lapackSupportsScalarType > | Stub implementation of BlockCGIter, for ScalarType types for which Teuchos::LAPACK does NOT have a valid implementation |
Belos::BlockCGIter< ScalarType, MV, OP, true > | Partial specialization for ScalarType types for which Teuchos::LAPACK has a valid implementation |
Belos::CGIter< ScalarType, MV, OP > | This class implements the preconditioned Conjugate Gradient (CG) iteration |
Belos::CGSingleRedIter< ScalarType, MV, OP > | This class implements the preconditioned single-reduction Conjugate Gradient (CG) iteration |
Belos::PseudoBlockCGIter< ScalarType, MV, OP > | This class implements the pseudo-block CG iteration, where the basic CG algorithm is performed on all of the linear systems simultaneously |
Belos::FixedPointIteration< ScalarType, MV, OP > | |
Belos::FixedPointIter< ScalarType, MV, OP > | This class implements the preconditioned fixed point iteration |
Belos::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 |
Belos::GmresIteration< ScalarType, MV, OP > | |
Belos::BlockFGmresIter< ScalarType, MV, OP > | This class implements the block flexible GMRES iteration, where a block 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 |
Belos::BlockGmresIter< ScalarType, MV, OP > | This class implements the block GMRES iteration, where a block 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 |
Belos::LSQRIter< ScalarType, MV, OP > | Implementation of the LSQR iteration |
Belos::MinresIteration< ScalarType, MV, OP > | |
Belos::MinresIter< ScalarType, MV, OP > | MINRES implementation |
Belos::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 |
Belos::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 |
Belos::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 |
Belos::RCGIter< ScalarType, MV, OP > | This class implements the RCG iteration, where a single-std::vector Krylov subspace is constructed |
Belos::StochasticCGIteration< ScalarType, MV, OP > | |
Belos::PseudoBlockStochasticCGIter< ScalarType, MV, OP > | This class implements the stochastic pseudo-block CG iteration, where the basic stochastic CG algorithm is performed on all of the linear systems simultaneously. The implementation is a pseudo-block generalization of the stochastic CG algorithm of Parker and Fox, SISC 2012 |
Belos::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 |
Teuchos::LabeledObject [external] | |
Teuchos::Describable [external] | |
Belos::Impl::SolverFactoryParent< Scalar, MV, OP > | Specializations of Belos::SolverFactory may inherit from this class to get basic SolverFactory functionality |
Belos::SolverManager< ScalarType, MV, OP > | The Belos::SolverManager is a templated virtual base class that defines the basic interface that any solver manager will support |
Belos::BiCGStabSolMgr< ScalarType, MV, OP > | The Belos::BiCGStabSolMgr provides a powerful and fully-featured solver manager over the pseudo-block BiCGStab iteration |
Belos::BlockGCRODRSolMgr< ScalarType, MV, OP > | A solver manager for the Block GCRO-DR (Block Recycling GMRES) linear solver |
Belos::BlockGmresSolMgr< ScalarType, MV, OP > | Interface to Block GMRES and Flexible GMRES |
Belos::Details::RealSolverManager< ScalarType, MV, OP, false > | |
Belos::LSQRSolMgr< ScalarType, MV, OP, false > | |
Belos::Details::RealSolverManager< ScalarType, MV, OP, true > | |
Belos::Details::SolverManagerRequiresLapack< ScalarType, MV, OP, false > | Specialization for ScalarType types for which Teuchos::LAPACK does NOT have a valid implementation |
Belos::Details::SolverManagerRequiresLapack< ScalarType, MV, OP, true > | Specialization for ScalarType types for which Teuchos::LAPACK has a valid implementation |
Belos::BlockCGSolMgr< ScalarType, MV, OP, true > | |
Belos::GCRODRSolMgr< ScalarType, MV, OP, true > | Partial specialization for ScalarType types for which Teuchos::LAPACK has a valid implementation |
Belos::PseudoBlockCGSolMgr< ScalarType, MV, OP, true > | |
Belos::Details::SolverManagerRequiresRealLapack< ScalarType, MV, OP, false > | Stub specialization for ScalarType types which are NOT real, or for which Teuchos::LAPACK does NOT have a valid implementation |
Belos::Details::SolverManagerRequiresRealLapack< ScalarType, MV, OP, true > | Non-stub specialization for real ScalarType types for which Teuchos::LAPACK has a valid implementation |
Belos::PCPGSolMgr< ScalarType, MV, OP, true > | |
Belos::RCGSolMgr< ScalarType, MV, OP, true > | |
Belos::FixedPointSolMgr< ScalarType, MV, OP > | The Belos::FixedPointSolMgr provides a powerful and fully-featured solver manager over the FixedPoint linear solver |
Belos::GmresPolySolMgr< ScalarType, MV, OP > | The GMRES polynomial can be created in conjunction with any standard preconditioner |
Belos::MinresSolMgr< ScalarType, MV, OP > | MINRES linear solver solution manager |
Belos::PseudoBlockGmresSolMgr< ScalarType, MV, OP > | Interface to standard and "pseudoblock" GMRES |
Belos::PseudoBlockStochasticCGSolMgr< ScalarType, MV, OP > | The Belos::PseudoBlockStochasticCGSolMgr provides a powerful and fully-featured solver manager over the pseudo-block CG iteration |
Belos::PseudoBlockTFQMRSolMgr< ScalarType, MV, OP > | The Belos::PseudoBlockTFQMRSolMgr provides a powerful and fully-featured solver manager over the pseudo-block TFQMR linear solver |
Belos::TFQMRSolMgr< ScalarType, MV, OP > | The Belos::TFQMRSolMgr provides a powerful and fully-featured solver manager over the TFQMR linear solver |
Belos::StatusTest< ScalarType, MV, OP > | A pure virtual class for defining the status tests for the Belos iterative solvers |
Belos::LSQRStatusTest< ScalarType, MV, OP > | |
Belos::StatusTestCombo< ScalarType, MV, OP > | A class for extending the status testing capabilities of Belos via logical combinations |
Belos::StatusTestLogResNorm< ScalarType, MV, OP > | A Belos::StatusTest debugging class for storing the absolute residual norms generated during a solve |
Belos::StatusTestMaxIters< ScalarType, MV, OP > | A Belos::StatusTest class for specifying a maximum number of iterations |
Belos::StatusTestOutput< ScalarType, MV, OP > | A virtual base class for StatusTest that print other status tests |
Belos::StatusTestGeneralOutput< ScalarType, MV, OP > | A special StatusTest for printing other status tests |
Belos::StatusTestResNormOutput< ScalarType, MV, OP > | A special StatusTest for printing other status tests in a simple format |
Belos::StatusTestUserOutput< ScalarType, MV, OP > | A special StatusTest for printing other status tests in a simple format |
Belos::StatusTestResNorm< ScalarType, MV, OP > | An abstract class of StatusTest for stopping criteria using residual norms |
Belos::StatusTestGenResNorm< ScalarType, MV, OP > | An implementation of StatusTestResNorm using a family of residual norms |
Belos::StatusTestGenResSubNorm< ScalarType, MV, OP > | An implementation of StatusTestResNorm using a family of norms of subvectors of the residual vectors |
Belos::StatusTestImpResNorm< ScalarType, MV, OP > | Convergence test using the implicit residual norm(s), with an explicit residual norm(s) check for loss of accuracy if necessary |
Belos::Impl::SolverFactoryParent< double, MultiVec< double >, Operator< double > > | |
Belos::BelosSolverFactory | |
Belos::Impl::SolverFactoryParent< SC, MV, OP > | |
Belos::GenericSolverFactory< SC, MV, OP > | |
Belos::Details::LapackSupportsScalar< ScalarType > | Type traits class that says whether Teuchos::LAPACK has a valid implementation for the given ScalarType |
Belos::Details::LapackSupportsScalar< double > | |
Belos::Details::LapackSupportsScalar< float > | |
Belos::LinearProblem< ScalarType, MV, OP > | A linear system to solve, and its associated information |
Trilinos::Details::LinearSolver< MV, OP, NormType > [external] | |
Belos::Details::LinearSolver< MV, OP, ScalarType, NormType > | Belos' implementation of Trilinos::Details::LinearSolver |
Trilinos::Details::LinearSolverFactory< MV, OP, NormType > [external] | |
Belos::Details::LinearSolverFactory< MV, OP, ScalarType, NormType > | |
Belos::details::LocalDenseMatrixOps< Scalar > | Low-level operations on non-distributed dense matrices |
logic_error | |
Belos::BelosError | Parent class to all Belos exceptions |
Belos::BiCGStabSolMgrLinearProblemFailure | BiCGStabSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::BiCGStabSolMgrOrthoFailure | BiCGStabSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::BlockCGSolMgrLinearProblemFailure | BlockCGSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::BlockCGSolMgrOrthoFailure | BlockCGSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::BlockGCRODRIterInitFailure | BlockGCRODRIterInitFailure is thrown when the BlockGCRODRIter object is unable to generate an initial iterate in the BlockGCRODRIter::initialize() routine |
Belos::BlockGCRODRIterOrthoFailure | BlockGCRODRIterOrthoFailure is thrown when the BlockGCRODRIter object is unable to compute independent direction vectors in the BlockGCRODRIter::iterate() routine |
Belos::BlockGCRODRSolMgrLAPACKFailure | Thrown when an LAPACK call fails |
Belos::BlockGCRODRSolMgrLinearProblemFailure | Thrown when the linear problem was not set up correctly |
Belos::BlockGCRODRSolMgrOrthoFailure | Thrown when the solution manager was unable to orthogonalize the basis vectors |
Belos::BlockGCRODRSolMgrRecyclingFailure | Thrown if any problem occurs in using or creating the recycle subspace |
Belos::BlockGmresSolMgrLinearProblemFailure | BlockGmresSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::BlockGmresSolMgrOrthoFailure | BlockGmresSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::CGIterateFailure | CGIterateFailure is thrown when the CGIteration object is unable to compute the next iterate in the CGIteration::iterate() routine |
Belos::CGIterationInitFailure | CGIterationInitFailure is thrown when the CGIteration object is unable to generate an initial iterate in the CGIteration::initialize() routine |
Belos::CGIterationLAPACKFailure | CGIterationLAPACKFailure is thrown when a nonzero return value is passed back from an LAPACK routine |
Belos::CGIterationOrthoFailure | CGIterationOrthoFailure is thrown when the CGIteration object is unable to compute independent direction vectors in the CGIteration::iterate() routine |
Belos::FixedPointIterateFailure | FixedPointIterateFailure is thrown when the FixedPointIteration object is unable to compute the next iterate in the FixedPointIteration::iterate() routine |
Belos::FixedPointIterationInitFailure | FixedPointIterationInitFailure is thrown when the FixedPointIteration object is unable to generate an initial iterate in the FixedPointIteration::initialize() routine |
Belos::FixedPointIterationLAPACKFailure | FixedPointIterationLAPACKFailure is thrown when a nonzero return value is passed back from an LAPACK routine |
Belos::FixedPointIterationOrthoFailure | FixedPointIterationOrthoFailure is thrown when the FixedPointIteration object is unable to compute independent direction vectors in the FixedPointIteration::iterate() routine |
Belos::FixedPointSolMgrLinearProblemFailure | FixedPointSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::GCRODRIterInitFailure | GCRODRIterInitFailure is thrown when the GCRODRIter object is unable to generate an initial iterate in the GCRODRIter::initialize() routine |
Belos::GCRODRIterOrthoFailure | GCRODRIterOrthoFailure is thrown when the GCRODRIter object is unable to compute independent direction vectors in the GCRODRIter::iterate() routine |
Belos::GCRODRSolMgrLAPACKFailure | GCRODRSolMgrLAPACKFailure is thrown when a nonzero value is retuned from an LAPACK call |
Belos::GCRODRSolMgrLinearProblemFailure | GCRODRSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::GCRODRSolMgrOrthoFailure | GCRODRSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::GCRODRSolMgrRecyclingFailure | GCRODRSolMgrRecyclingFailure is thrown when any problem occurs in using/creating the recycling subspace |
Belos::GmresIterationInitFailure | GmresIterationInitFailure is thrown when the GmresIteration object is unable to generate an initial iterate in the GmresIteration::initialize() routine |
Belos::GmresIterationLAPACKFailure | GmresIterationLAPACKFailure is thrown when a nonzero return value is passed back from an LAPACK routine |
Belos::GmresIterationOrthoFailure | GmresIterationOrthoFailure is thrown when the GmresIteration object is unable to compute independent direction vectors in the GmresIteration::iterate() routine |
Belos::GmresPolyOpOrthoFailure | GmresPolyOpOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::GmresPolySolMgrLinearProblemFailure | GmresPolySolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::GmresPolySolMgrPolynomialFailure | GmresPolySolMgrPolynomialFailure is thrown when their is a problem generating the GMRES polynomial for this linear problem |
Belos::LinearProblemError | Exception thrown to signal error with the Belos::LinearProblem object |
Belos::LSQRIterateFailure | LSQRIterateFailure is thrown when the LSQRIteration object is unable to compute the next iterate in the iterate() routine |
Belos::LSQRIterationInitFailure | LSQRIterationInitFailure is thrown when the LSQRIteration object is unable to generate an initial iterate in the initialize() routine |
Belos::LSQRIterationLAPACKFailure | LSQRIterationLAPACKFailure is thrown when a nonzero return value is passed back from an LAPACK routine |
Belos::LSQRIterationOrthoFailure | LSQRIterationOrthoFailure is thrown when the LSQRIteration object is unable to compute independent direction vectors in the iterate() routine |
Belos::LSQRSolMgrBlockSizeFailure | LSQRSolMgrBlockSizeFailure is thrown when the linear problem has more than one RHS |
Belos::LSQRSolMgrLinearProblemFailure | Belos::LSQRSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::LSQRSolMgrOrthoFailure | LSQRSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::MinresIterateFailure | MinresIterateFailure is thrown when the MinresIteration object is unable to compute the next iterate in the MinresIteration::iterate() routine |
Belos::MinresIterationInitFailure | MinresIterationInitFailure is thrown when the MinresIteration object is unable to generate an initial iterate in the MinresIteration::initialize() routine |
Belos::MinresIterationLAPACKFailure | MinresIterationLAPACKFailure is thrown when a nonzero return value is passed back from an LAPACK routine |
Belos::MinresIterationOrthoFailure | MinresIterationOrthoFailure is thrown when the MinresIteration object is unable to compute independent direction vectors in the MinresIteration::iterate() routine |
Belos::MinresSolMgrLinearProblemFailure | This subclass of std::exception may be thrown from the MinresSolMgr::solve() method |
Belos::OrthoError | Exception thrown to signal error in an orthogonalization manager method |
Belos::TsqrOrthoError | Error in TsqrOrthoManager or TsqrOrthoManagerImpl |
Belos::TsqrOrthoFault | Orthogonalization fault |
Belos::PCPGIterateFailure | PCPGIterateFailure is thrown when the PCPGIter object breaks down |
Belos::PCPGIterInitFailure | PCPGIterInitFailure is thrown when the PCPGIter object is unable to generate an initial iterate in the PCPGIter::initialize() routine |
Belos::PCPGIterLAPACKFailure | PCPGIterLAPACKFailure is thrown when a nonzero return value is passed back from an LAPACK routine |
Belos::PCPGIterOrthoFailure | PCPGIterOrthoFailure is thrown when the PCPGIter object is unable to compute independent direction vectors in the PCPGIter::iterate() routine |
Belos::PCPGSolMgrLAPACKFailure | PCPGSolMgrLAPACKFailure is thrown when a nonzero value is retuned from an LAPACK call |
Belos::PCPGSolMgrLinearProblemFailure | PCPGSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::PCPGSolMgrOrthoFailure | PCPGSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::PCPGSolMgrRecyclingFailure | PCPGSolMgrRecyclingFailure is thrown when any problem occurs in using/creating the recycling subspace |
Belos::PseudoBlockCGSolMgrLinearProblemFailure | PseudoBlockCGSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::PseudoBlockCGSolMgrOrthoFailure | PseudoBlockCGSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::PseudoBlockGmresIterInitFailure | PseudoBlockGmresIterInitFailure is thrown when the PseudoBlockGmresIter object is unable to generate an initial iterate in the PseudoBlockGmresIter::initialize() routine |
Belos::PseudoBlockGmresIterOrthoFailure | PseudoBlockGmresIterOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the new basis vectors |
Belos::PseudoBlockGmresSolMgrLinearProblemFailure | PseudoBlockGmresSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::PseudoBlockGmresSolMgrOrthoFailure | PseudoBlockGmresSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::PseudoBlockStochasticCGSolMgrLinearProblemFailure | PseudoBlockStochasticCGSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::PseudoBlockStochasticCGSolMgrOrthoFailure | PseudoBlockStochasticCGSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::PseudoBlockTFQMRIterateFailure | PseudoBlockTFQMRIterateFailure is thrown when the PseudoBlockTFQMRIter object is unable to compute the next iterate in the PseudoBlockTFQMRIter::iterate() routine |
Belos::PseudoBlockTFQMRIterInitFailure | PseudoBlockTFQMRIterInitFailure is thrown when the PseudoBlockTFQMRIter object is unable to generate an initial iterate in the PseudoBlockTFQMRIter::initialize() routine |
Belos::PseudoBlockTFQMRSolMgrLinearProblemFailure | PseudoBlockTFQMRSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::PseudoBlockTFQMRSolMgrOrthoFailure | PseudoBlockTFQMRSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::RCGIterFailure | RCGIterFailure is thrown when the RCGIter object is unable to compute the next iterate in the RCGIter::iterate() routine |
Belos::RCGIterInitFailure | RCGIterInitFailure is thrown when the RCGIter object is unable to generate an initial iterate in the RCGIter::initialize() routine |
Belos::RCGIterLAPACKFailure | RCGIterLAPACKFailure is thrown when a nonzero return value is passed back from an LAPACK routine |
Belos::RCGIterOrthoFailure | RCGIterOrthoFailure is thrown when the RCGIter object is unable to compute independent direction vectors in the RCGIter::iterate() routine |
Belos::RCGSolMgrLAPACKFailure | RCGSolMgrLAPACKFailure is thrown when a nonzero value is retuned from an LAPACK call |
Belos::RCGSolMgrLinearProblemFailure | RCGSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::RCGSolMgrRecyclingFailure | RCGSolMgrRecyclingFailure is thrown when any problem occurs in using/creating the recycling subspace |
Belos::StatusTestError | Exception thrown to signal error in a status test during Belos::StatusTest::checkStatus() |
Belos::TFQMRIterateFailure | TFQMRIterateFailure is thrown when the TFQMRIter object is unable to compute the next iterate in the TFQMRIter::iterate() routine |
Belos::TFQMRIterInitFailure | TFQMRIterInitFailure is thrown when the TFQMRIter object is unable to generate an initial iterate in the TFQMRIter::initialize() routine |
Belos::TFQMRSolMgrLinearProblemFailure | TFQMRSolMgrLinearProblemFailure is thrown when the linear problem is not setup (i.e |
Belos::TFQMRSolMgrOrthoFailure | TFQMRSolMgrOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonormal columns from the initial basis vectors |
Belos::LSQRIterationState< ScalarType, MV > | Structure to contain pointers to LSQRIteration state variables, .. |
LSQRStatusTest | A 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 |
Belos::MinresIterationState< ScalarType, MV > | Structure to contain pointers to MinresIteration state variables |
Belos::MultiVec< ScalarType > | Interface for multivectors used by Belos' linear solvers |
Belos::GmresPolyMv< ScalarType, MV > | |
MyMultiVec< ScalarType > | Simple example of a user's defined Belos::MultiVec class |
Belos::MultiVecTraits< ScalarType, MV > | Traits class which defines basic operations on multivectors |
Belos::MultiVecTraits< ScalarType, MultiVec< ScalarType > > | Specialization of MultiVecTraits for Belos::MultiVec |
Belos::details::MultiVecTsqrAdapter< ScalarType > | TSQR adapter for MultiVec |
Belos::Operator< ScalarType > | Alternative run-time polymorphic interface for operators |
Belos::GmresPolyOp< ScalarType, MV, OP > | Belos's class for applying the GMRES polynomial operator that is used by the hybrid-GMRES linear solver |
MyBetterOperator< ScalarType > | Simple example of a user's defined Belos::Operator class |
MyOperator< ScalarType > | Simple example of a user's defined Belos::Operator class |
Belos::OperatorT< MV > | |
Belos::OperatorTraits< ScalarType, MV, OP > | Class which defines basic traits for the operator type |
Belos::OperatorTraits< Scalar, MV, InnerSolver< Scalar, MV, OP > > | Partial specialization of OperatorTraits for InnerSolver |
Belos::OperatorTraits< ScalarType, MultiVec< ScalarType >, Operator< ScalarType > > | Specialization of OperatorTraits for Operator and MultiVec |
Belos::OperatorTraits< ScalarType, MV, OperatorT< MV > > | Specialization of OperatorTraits for OperatorT |
Belos::Test::OrthoManagerBenchmarker< Scalar, MV > | OrthoManager benchmark |
Belos::OrthoManagerFactory< Scalar, MV, OP > | Enumeration of all valid Belos (Mat)OrthoManager classes |
Belos::OrthoManagerFactory< ScalarType, MV, OP > | |
Belos::Test::OrthoManagerTester< Scalar, MV > | Wrapper around OrthoManager test functionality |
Belos::OutOfPlaceNormalizerMixin< Scalar, MV > | Mixin for out-of-place orthogonalization |
Belos::TsqrMatOrthoManager< Scalar, MV, OP > | MatOrthoManager subclass using TSQR or DGKS |
Belos::TsqrOrthoManager< Scalar, MV > | TSQR-based OrthoManager subclass |
Belos::OutputManager< ScalarType > | Belos's basic output manager for sending information of select verbosity levels to the appropriate output stream |
Belos::OutputManager< Scalar > | |
Teuchos::ParameterListAcceptor [external] | |
Teuchos::ParameterListAcceptorDefaultBase [external] | |
Belos::details::StubTsqrAdapter< MultiVectorType > | "Stub" TSQR adaptor for unsupported multivector types |
Belos::OrthoManager< ScalarType, MV > | Belos's templated virtual class for providing routines for orthogonalization and orthonormzalition of multivectors |
Belos::MatOrthoManager< ScalarType, MV, OP > | Belos's templated virtual class for providing routines for orthogonalization and orthonormzalition of multivectors using matrix-based inner products |
Belos::DGKSOrthoManager< ScalarType, MV, OP > | An implementation of the Belos::MatOrthoManager that performs orthogonalization using (potentially) multiple steps of classical Gram-Schmidt |
Belos::ICGSOrthoManager< ScalarType, MV, OP > | An implementation of the Belos::MatOrthoManager that performs orthogonalization using multiple steps of classical Gram-Schmidt |
Belos::IMGSOrthoManager< ScalarType, MV, OP > | An implementation of the Belos::MatOrthoManager that performs orthogonalization using multiple steps of modified Gram-Schmidt |
Belos::MatOrthoManager< Scalar, MV, OP > | |
Belos::TsqrMatOrthoManager< Scalar, MV, OP > | MatOrthoManager subclass using TSQR or DGKS |
Belos::TsqrOrthoManagerImpl< Scalar, MV > | TSQR-based OrthoManager subclass implementation |
Belos::OrthoManager< Scalar, MV > | |
Belos::SimpleOrthoManager< Scalar, MV > | Simple OrthoManager implementation for benchmarks |
Belos::TsqrOrthoManager< Scalar, MV > | TSQR-based OrthoManager subclass |
Belos::OrthoManager< Scalar, MV > | |
Belos::PCPGIterState< ScalarType, MV > | Structure to contain pointers to PCPGIter state variables |
Belos::details::ProjectedLeastSquaresProblem< Scalar > | "Container" for the GMRES projected least-squares problem |
Belos::details::ProjectedLeastSquaresSolver< Scalar > | Methods for solving GMRES' projected least-squares problem |
Belos::PseudoBlockGmresIterState< ScalarType, MV > | Structure to contain pointers to PseudoBlockGmresIter state variables |
Belos::PseudoBlockTFQMRIterState< ScalarType, MV > | Structure to contain pointers to PseudoBlockTFQMRIter state variables |
Belos::RCGIterState< ScalarType, MV > | Structure to contain pointers to RCGIter state variables |
Belos::Details::RealSolverManager< ScalarType, MV, OP, isComplex > | Base class for Belos::SolverManager subclasses which normally can only compile for real ScalarType |
Belos::Details::RealSolverManager< ScalarType, MV, OP, Teuchos::ScalarTraits< ScalarType >::isComplex > | |
Belos::LSQRSolMgr< ScalarType, MV, OP, scalarTypeIsComplex > | LSQR method (for linear systems and linear least-squares problems) |
Belos::Impl::SolverFactorySelector< SC, MV, OP > | |
Belos::Impl::SolverFactorySelector< double, MultiVec< double >, Operator< double > > | |
Belos::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 |
Belos::Details::SolverManagerRequiresLapack< ScalarType, MV, OP > | |
Belos::BlockCGSolMgr< ScalarType, MV, OP, lapackSupportsScalarType > | The Belos::BlockCGSolMgr provides a powerful and fully-featured solver manager over the CG and BlockCG linear solver |
Belos::GCRODRSolMgr< ScalarType, MV, OP, lapackSupportsScalarType > | Implementation of the GCRODR (Recycling GMRES) iterative linear solver |
Belos::Details::SolverManagerRequiresLapack< ScalarType, MV, OP, Belos::Details::LapackSupportsScalar< ScalarType >::value > | |
Belos::PseudoBlockCGSolMgr< ScalarType, MV, OP, supportsScalarType > | The Belos::PseudoBlockCGSolMgr provides a powerful and fully-featured solver manager over the pseudo-block CG iteration |
Belos::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 |
Belos::Details::SolverManagerRequiresRealLapack< ScalarType, MV, OP, Belos::Details::LapackSupportsScalar< ScalarType >::value &&!Teuchos::ScalarTraits< ScalarType >::isComplex > | |
Belos::PCPGSolMgr< ScalarType, MV, OP, supportsScalarType > | PCPG iterative linear solver |
Belos::RCGSolMgr< ScalarType, MV, OP, supportsScalarType > | Implementation of the RCG (Recycling Conjugate Gradient) iterative linear solver |
Belos::StatusTestFactory< Scalar, MV, OP > | Factory to build a set of status tests from a parameter list |
Belos::StatusTestOutputFactory< ScalarType, MV, OP > | A factory class for generating StatusTestOutput objects |
Belos::StochasticCGIterationState< ScalarType, MV > | Structure to contain pointers to CGIteration state variables |
Belos::TFQMRIterState< ScalarType, MV > | Structure to contain pointers to TFQMRIter state variables |
Belos::UndefinedMultiVecTraits< ScalarType, MV > | Used by MultiVecTraits to report lack of a specialization |
Belos::UndefinedOperatorTraits< ScalarType, MV, OP > | Class used to require specialization of OperatorTraits |
Belos::UndefinedWrapperType< Scalar, MV, OP > | Undefined wrapper type, to check at compile time whether InnerSolverTraits has been specialized |