NOX  Development
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 1234567]
 CLOCA::StatusTest::Abstract
 CLOCA::Parameter::AbstractEntryAbstract interface for all entries in LOCA::Parameter::Library
 CLOCA::BorderedSolver::AbstractOperatorAbstract interface class representing an operator for solving bordered sets of linear equations
 CLOCA::AnasaziOperator::AbstractStrategyAbstract interface class for Anasazi operator strategies
 CLOCA::MultiPredictor::AbstractStrategyAbstract interface class for predictor strategies
 CLOCA::BorderedSolver::AbstractStrategyAbstract interface class for solving bordered sets of linear equations
 CLOCA::SaveEigenData::AbstractStrategyAbstract interface class strategies to save eigenvector/value data
 CLOCA::StepSize::AbstractStrategyAbstract interface class for step size control strategies
 CLOCA::Eigensolver::AbstractStrategyAbstract interface class for Eigensolver strategies
 CLOCA::EigenvalueSort::AbstractStrategyAbstract interface for eigenvalue sorting strategies
 CLOCA::Epetra::TransposeLinearSystem::AbstractStrategyA pure virtual interface for solving the transpose of a linear system
 CLOCA::Thyra::AdaptiveSolutionManager
 CNOX::Epetra::AdaptiveSolutionManager
 CNOX::Epetra::AdaptManager
 CNOX::Direction::Broyden::BroydenMemoryUtility class for NOX::Direction::Broyden method to manage the information stored in "limited" memory
 CNOX::Direction::Broyden::BroydenMemoryUnitUtility class for NOX::Direction::Broyden::BroydenMemory
 CLOCA::MultiContinuation::ConstraintInterfaceAbstract interface for the constraint portion of a constrained nonlinear system
 CContinuationManager
 CNOX::LineSearch::Utils::CountersCommon counters that all line search algorithms should report
 CLOCA::Parameter::DefaultFunctor< ObjectType, ValueType >Default function object for setting a single parameter in a single object using a data member pointer
 CThyra::DefaultLinearOpSource< Scalar >
 CLOCA::DerivUtilsLOCA's generic derivative computation class to compute various derivatives via finite differencing
 CEpetra_Operator
 CEpetra_RowMatrix
 CLOCA::ErrorCheckAn Error checking algorithm for NOX/LOCA routines
 CLOCA::Abstract::FactoryAbstract interface for providing a user-defined factory
 CNOX::Direction::FactoryFactory to build direction objects derived from NOX::Direction::Generic
 CLOCA::MultiContinuation::FactoryFactory for creating continuation strategy objects
 CLOCA::AnasaziOperator::FactoryFactory for creating Anasazi operator strategy objects
 CNOX::LineSearch::FactoryFactory to build line search objects derived from NOX::LineSearch::Generic
 CLOCA::MultiPredictor::FactoryFactory for creating Predictor strategy objects
 CLOCA::Bifurcation::FactoryFactory for creating bifurcation strategy objects
 CNOX::Solver::FactoryFactory class to control the creation of solvers derived from the NOX::Solver::Generic object
 CLOCA::BorderedSolver::FactoryFactory for creating BorderedSolver strategy objects
 CLOCA::SaveEigenData::FactoryFactory for creating strategy objects to save eigenvectors/values
 CLOCA::StatusTest::FactoryFactory to build a set of status tests from a parameter list
 CLOCA::StepSize::FactoryFactory for creating step size control strategy objects
 CLOCA::Eigensolver::FactoryFactory for creating Eigensolver strategy objects
 CNOX::StatusTest::FactoryFactory to build a set of status tests from a parameter list
 CLOCA::EigenvalueSort::FactoryFactory for creating EigenvalueSort strategy objects
 CLOCA::FactoryFactory class for creating strategies
 CLOCA::Epetra::TransposeLinearSystem::FactoryFactory for creating transpose linear system strategy objects
 CNOX::Utils::FillFill object - used to print the given character the number of times specified
 CLOCA::Epetra::Interface::FreeEnergyUsed by LOCA::Epetra::Group to provide a link to the external code for computing the free energy
 CNOX::LineSearch::GenericBase class line search interface
 CNOX::Direction::GenericGeneric direction interface
 CNOX::Solver::GenericAbstract nonlinear solver method interface
 CLOCA::SingularJacobianSolve::GenericGeneric singular jacobian solve interface
 CNOX::StatusTest::GenericGeneric status test to check for convergence or failure of the nonlinear solver
 CNOX::MeritFunction::GenericBase class to support a user defined merit function that can be passed to line searches and directions through the parameter list
 CNOX::GlobalDataContainer class to hold "global" NOX objects
 CLOCA::GlobalDataContainer class to hold "global" LOCA objects
 CNOX::Abstract::GroupNOX pure abstract interface to a "group"; i.e., a solution vector and the corresponding F-vector, Jacobian matrix, gradient vector, and Newton vector
 CLOCA::BorderedSolver::HouseholderQRA convenience class to compute the QR factorization of a an extended multi-vector
 CNOX::Abstract::ImplicitWeightingA pure virtual interface for enabling/disabling any user defined implicit weighting of the concrete object
 CNOX::Direction::Utils::InexactNewtonInexact Newton Utilities
 CNOX::Multiphysics::DataExchange::InterfaceProvides a set of interfaces for users to provide information about exchanging data between registered NOX solvers
 CNOX::Petsc::InterfaceUsed by NOX::Petsc::Group to provide a link to the external code for F and Jacobian evaluations (if needed)
 CNOX::LAPACK::InterfaceVirtual interface for NOX::BLAS::Group to provide a link to the external code for RHS and Jacobian fills
 CLOCA::Abstract::IteratorAn abstract interface for implementing iteration
 CNOX::Epetra::Interface::JacobianUsed by NOX::Epetra to provide a link to the external code for Jacobian fills
 CLOCA::Parameter::LibraryClass to provide a centralized library for setting/retrieving numerical parameter values in application codes
 CThyra::LinearOpBase< Scalar >
 CThyra::LinearOpWithSolveBase< Scalar >
 CThyra::LinearOpWithSolveFactoryBase< Scalar >
 CNOX::LAPACK::LinearSolver< T >A simple linear solver for use by NOX::LAPACK::Group
 CNOX::LAPACK::LinearSolver< double >
 CNOX::Epetra::LinearSystemPure virtual class interface for allowing different linear solvers to be used by the NOX::Epetra::Group
 CLOCAData
 CLOCANVectorData
 CLOCA::BorderedSolver::LowerTriangularBlockEliminationBlock elimination strategy for solving a block lower-triangular system
 CLOCA::Epetra::Interface::MassMatrixUsed by LOCA::Epetra::Group to provide a link to the external code for the MassMatrix (coefficients of time dependent terms)
 CNOX::LAPACK::Matrix< T >A simple square matrix class for use by NOX::LAPACK::Group
 CNOX::LAPACK::Matrix< double >
 CThyra::ModelEvaluator< Scalar >
 CModelEvaluatorDelegatorBase
 CModelEvaluatorInterface
 CLOCA::MultiStepperImplementation of LOCA::Abstract::Iterator for computing points along a continuation curve
 CNOX::Abstract::MultiVectorAbstract interface for multi-vectors used by NOX
 CThyra::MultiVectorBase< Scalar >
 CAnasazi::MultiVecTraits< double, NOX::Abstract::MultiVector >Implementation of the Anasazi::MultiVecTraits for NOX::Abstract::MultiVectors
 CNonlinearSolverBase
 CNOX::Epetra::Observer
 CAnasazi::OperatorTraits< double, NOX::Abstract::MultiVector, LOCA::AnasaziOperator::AbstractStrategy >Implementation of the Anasazi::OperatorTraits for LOCA operators
 CNOX::Petsc::OptionsClass to convert solver options from command line (or command input file) into a form usable by NOX
 CParamData
 CParameterListAcceptorDefaultBase
 CLOCA::ParameterVectorLOCA's container for holding a set of parameters that are used by the LOCA continuation routines
 CNOX::Epetra::Interface::PreconditionerUsed by NOX::Epetra to provide a link to the external code for Precondtioner fills
 CThyra::PreconditionerBase< Scalar >
 CThyra::PreconditionerFactoryBase< Scalar >
 CNOX::Abstract::PrePostOperatorNOX's pure virtual class to allow users to insert pre and post operations into nox's solvers (before and after the NOX::Solver::Generic::iterate() and NOX::Solver::Generic::solve() methods)
 CNOX::Solver::PrePostOperatorFunctor to process the pre/post operator object in the parameter list
 CProblemNOXPrototype
 CNOX::RandomA class to compute uniformly distributed random numbers in (-1,1)
 CNOX::Epetra::BroydenOperator::ReplacementInterface
 CNOX::Epetra::Interface::RequiredSupplies NOX with the set nonlinear equations
 CLOCA::Thyra::SaveDataStrategyAbstract interface class strategies to save continuation data
 CNOX::Epetra::ScalingObject to control scaling of vectors and linear systems
 CNOX::Utils::SciSci object - used to print the given value with the specified precision
 CNOX::Petsc::SharedJacobianShared Jacobian for NOX::Petsc::Group objects
 CNOX::SharedObject< Object, Owner >Holder for objects that are shared between NOX::Abstract::Groups
 CNOX::SharedObject< NOX::Epetra::NOX::Epetra::LinearSystem, NOX::Epetra::NOX::Epetra::Group >
 CNOX::LineSearch::Utils::SlopeCommon line search utilites for computing the slope of a function
 CLOCA::Hopf::MooreSpence::SolverFactoryFactory for creating solver objects for solving Moore-Spence Hopf equations
 CLOCA::TurningPoint::MooreSpence::SolverFactoryFactory for creating solver objects for solving Moore-Spence turning point equations
 CLOCA::Pitchfork::MooreSpence::SolverFactoryFactory for creating solver objects for solving Moore-Spence pitchfork equations
 CLOCA::Pitchfork::MooreSpence::SolverStrategyAbstract strategy for solving the Moore-Spence pitchfork equations
 CLOCA::TurningPoint::MooreSpence::SolverStrategyAbstract strategy for solving the Moore-Spence turning point equations
 CLOCA::Hopf::MooreSpence::SolverStrategyAbstract strategy for solving the Moore-Spence Hopf equations
 CSortManager
 CLOCA::Parameter::SublistParserClass to parse a parameter list for sublists
 CTOp_1_1_Base
 CRTOpPack::TOpEleWiseMinSwapEleWiseTransformation< Scalar >Element-wise transformation operator for TOpEleWiseMinSwap
 CLOCA::BorderedSolver::UpperTriangularBlockEliminationBlock elimination strategy for solving a block upper-triangular system
 CNOX::LineSearch::UserDefinedFactoryPure virtual interface for users to supply their own line search objects
 CNOX::Direction::UserDefinedFactoryPure virtual interface for users to supply their own direction objects
 CNOX::UtilsProvides printing utilities
 CNOX::Abstract::VectorNOX's pure abstract vector interface for vectors that are used by the nonlinear solver
 CThyra::VectorBase< Scalar >
 CNOX::Epetra::VectorSpacePure virtual base class for the vector space used by NOX::Epetra::Vectors