ROL
Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 12345]
 CROL::Algorithm< Real >Provides an interface to run optimization algorithms
 CROL::AlgorithmState< Real >State for algorithm class. Will be used for restarts
 Cbasic_ostream
 CROL::BatchManager< Real >
 CBinaryFunction
 CROL::BoundConstraint< Real >Provides the interface to apply upper and lower bound constraints
 CROL::Bundle< Real >Provides the interface for and implements a bundle
 CBurgersFEM< Real >
 CConicApproximationModelProvides the interface to evaluate conic approximation function
 CROL::Constraint< Real >Defines the general constraint operator interface
 CROL::ConstraintManager< Real >Provides a wrapper for multiple constraints
 CROL::Distribution< Real >
 CROL::details::DynamicConstraint_CheckInterface< Real >
 CROL::DynamicConstraintCheck< Real >
 CROL::DynamicFunction< Real >Provides update interface, casting and vector management to DynamicConstraint and DynamicObjective
 CROL::DynamicObjective< Real >Defines the time-dependent objective function interface for simulation-based optimization. Computes time-local contributions of value, gradient, Hessian-vector product etc to a larger composite objective defined over the simulation time. In contrast to other objective classes Objective_TimeSimOpt has a default implementation of value which returns zero, as time-dependent simulation based optimization problems may have an objective value which depends only on the final state of the system
 CROL::details::DynamicObjective_CheckInterface< Real >
 CROL::DynamicObjectiveCheck< Real >
 CExample_Objective< Real >Objective function:

\[f(x) = exp(x_1 x_2 x_3 x_4 x_5) + \frac{1}{2}*(x_1^3+x_2^3+1)^2 \]

 CROL::ExpectationQuad< Real >Provides a general interface for risk and error measures generated through the expectation risk quadrangle
 CFEM< Real >
 CFiniteDifference< Real >
 CFunctionZakharov< ScalarT >
 CFunctionZakharov< GradType >
 CFunctionZakharov< HessVecType >
 CFunctionZakharov< Real >
 CInnerProductMatrix< Real >
 CROL::Krylov< Real >Provides definitions for Krylov solvers
 CLagrange< Real >
 CROL::Lanczos< Real >Interface for computing the Lanczos vectors and approximate solutions to symmetric indefinite linear systems
 CROL::LinearOperator< Real >Provides the interface to apply a linear operator
 CROL::LinearRegression< Real >Provides the interface to construct linear regression problem
 CROL::LineSearch< Real >Provides interface for and implements line searches
 Clogic_error
 CROL::MINRESImplements the MINRES algorithm for solving symmetric indefinite systems
 CNodalBasis< Real >
 CROL::Objective< Real >Provides the interface to evaluate objective functions
 CROL::OptimizationProblem< Real >
 CROL::OptimizationSolver< Real >Provides a simplified interface for solving a wide range of optimization problems
 CROL::PenalizedObjectiveAdds barrier term to generic objective
 Cdetails::PolarizationIdentity< Real >
 CROL::PositiveFunction< Real >
 CROL::PrimalDualInteriorPointReducedResidualReduced form of the Primal Dual Interior Point residual and the action of its Jacobian
 CROL::ProgressiveHedging< Real >Provides the interface to solve a stochastic program using progressive hedging
 CROL::RandVarFunctional< Real >Provides the interface to implement any functional that maps a random variable to a (extended) real number
 CReductionOp
 CROL::removeSpecialCharacters
 CROL::RiskMeasure< Real >Provides the interface to implement risk measures
 CROL::SampledScalar< Real >
 CROL::SampledVector< Real >
 CROL::SampleGenerator< Real >
 CScalarFunction
 CScalarFunction
 CScalarMinimizationStatusTest
 CROL::ScalarTraits< Real >
 CROL::ScalarTraits_Magnitude< Real >
 CROL::ScalarTraits_Magnitude< std::complex< Real > >
 CROL::SchurComplementGiven a 2x2 block operator, perform the Schur reduction and return the decoupled system components
 CROL::SecantState< Real >
 CROL::SemismoothNewtonDualModelImplements the dual variable model function for a semismooth Newton step
 CROL::SerialConstraintEvaluates ROL::DynamicConstraint over a sequential set of time intervals
 CROL::SimController< Real >
 CROL::Sketch< Real >Provides an interface for randomized sketching
 CROL::StatusTest< Real >Provides an interface to check status of optimization algorithms
 CROL::StatusTestFactory< Real >
 CROL::StdLinearOperatorFactoryCreates StdLinearOperator objects which wrap random

matrices of the desired size and property

 CROL::Step< Real >Provides the interface to compute optimization steps
 CROL::StepFactory< Real >
 CROL::StepState< Real >State for step class. Will be used for restarts
 CTestMulti< Real >
 CROL::TestProblem< Real >
 CTestSingle< Real >
 CTeuchosBatchManager
 CROL::TimeStamp< Real >Contains local time step information
 CROL::TrustRegion< Real >Provides interface for and implements trust-region subproblem solvers
 CROL::TypeCaster< Real, Element >
 CROL::TypeCaster< double, float >
 CROL::TypeCaster< Real, std::complex< Real > >
 CUnaryFunction
 CROL::Vector< Real >Defines the linear algebra or vector space interface
 CROL::details::VectorClone< Real >
 CROL::VectorCloneContainer for wrapping a reusable cloned vector. Declaring an object of this type as a class member variable will decrease the number of clones needed as memory need only be allocated once in the lifetime of the host object. Verifies that member and argument types and dimensions agree when called
 CROL::details::VectorCloneMap< Real, KeyType >
 CROL::VectorCloneMapContainer for wrapping a collection of uniquely-named reusable cloned vectors, which in are stored in a map. Uses string-valued ids for keys by default
 CROL::details::VectorCloneMap< Real >
 CROL::VectorFunctionCalls< Ordinal >
 CROL::details::VectorWorkspace< Real >::VectorKey
 CROL::details::VectorWorkspace< Real >::VectorStack
 CROL::VectorWorkspaceProvides a "smart" cloning manager to be used a member variable in a class and called in the member function of the same class
 CROL::details::VectorWorkspace< Real >
 CROL::WrappedVectorProvides an interface layer which encapulates a pointer to a ROL::Vector and has the default behavior of calling its member Ptr<Vector> object. Makes creating derived classes with this idiom simpler as they need only override the methods where the desired implementation differs from the member Ptr<Vector>. For example, vectors which have a diagonal scaling that defines their inner product and dual spaces can derive from this class need overload only the methods basis, clone, dual, and dot
 CROL::WrappedVector< Real >
 CZakharov< Real >