ROL
Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 12345]
oCROL::Algorithm< Real >Provides an interface to run optimization algorithms
oCROL::AlgorithmState< Real >State for algorithm class. Will be used for restarts
oCbasic_ostream
oCROL::BatchManager< Real >
oCBinaryFunction
oCROL::BoundConstraint< Real >Provides the interface to apply upper and lower bound constraints
oCROL::Bundle< Real >Provides the interface for and implements a bundle
oCBurgersFEM< Real >
oCConicApproximationModelProvides the interface to evaluate conic approximation function
oCROL::Constraint< Real >Defines the general constraint operator interface
oCROL::ConstraintManager< Real >Provides a wrapper for multiple constraints
oCROL::Distribution< Real >
oCROL::details::DynamicConstraint_CheckInterface< Real >
oCROL::DynamicConstraintCheck< Real >
oCROL::DynamicFunction< Real >Provides update interface, casting and vector management to DynamicConstraint and DynamicObjective
oCROL::details::DynamicObjective_CheckInterface< Real >
oCROL::DynamicObjectiveCheck< Real >
oCExample_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 \]

oCROL::ExpectationQuad< Real >Provides a general interface for risk and error measures generated through the expectation risk quadrangle
oCROL::ExplicitLinearConstraint< Real >Performs null-space transformation for explicit linear equality constraints
oCFEM< Real >
oCFiniteDifference< Real >
oCFunctionZakharov< ScalarT >
oCFunctionZakharov< GradType >
oCFunctionZakharov< HessVecType >
oCFunctionZakharov< Real >
oCInnerProductMatrix< Real >
oCROL::Krylov< Real >Provides definitions for Krylov solvers
oCLagrange< Real >
oCROL::Lanczos< Real >Interface for computing the Lanczos vectors and approximate solutions to symmetric indefinite linear systems
oCROL::LinearOperator< Real >Provides the interface to apply a linear operator
oCROL::LinearRegression< Real >Provides the interface to construct linear regression problem
oCROL::LineSearch< Real >Provides interface for and implements line searches
oClogic_error
oCROL::MINRESImplements the MINRES algorithm for solving symmetric indefinite systems
oCNodalBasis< Real >
oCROL::Objective< Real >Provides the interface to evaluate objective functions
oCROL::OptimizationProblem< Real >
oCROL::OptimizationProblemCheckData< Real >
oCROL::OptimizationSolver< Real >Provides a simplified interface for solving a wide range of optimization problems
oCROL::PenalizedObjectiveAdds barrier term to generic objective
oCdetails::PolarizationIdentity< Real >
oCROL::PositiveFunction< Real >
oCROL::PrimalDualInteriorPointReducedResidualReduced form of the Primal Dual Interior Point residual and the action of its Jacobian
oCROL::PrimalDualRisk< Real >
oCROL::ProgressiveHedging< Real >Provides the interface to solve a stochastic program using progressive hedging
oCROL::RandVarFunctional< Real >Provides the interface to implement any functional that maps a random variable to a (extended) real number
oCReductionOp
oCROL::removeSpecialCharacters
oCROL::RiskMeasure< Real >Provides the interface to implement risk measures
oCROL::SampledScalar< Real, Key >
oCROL::SampledVector< Real, Key >
oCROL::SampleGenerator< Real >
oCScalarFunction
oCScalarFunction
oCScalarMinimizationStatusTest
oCROL::ScalarTraits< Real >
oCROL::ScalarTraits_Magnitude< Real >
oCROL::ScalarTraits_Magnitude< std::complex< Real > >
oCROL::SchurComplementGiven a 2x2 block operator, perform the Schur reduction and return the decoupled system components
oCROL::SecantState< Real >
oCROL::SemismoothNewtonDualModelImplements the dual variable model function for a semismooth Newton step
oCROL::SerialFunction< Real >Provides behavior common to SerialObjective as SerialConstaint
oCROL::SimController< Real, Key >
oCROL::Sketch< Real >Provides an interface for randomized sketching
oCROL::StatusTest< Real >Provides an interface to check status of optimization algorithms
oCROL::StatusTestFactory< Real >
oCROL::StdLinearOperatorFactoryCreates StdLinearOperator objects which wrap random

matrices of the desired size and property

oCROL::Step< Real >Provides the interface to compute optimization steps
oCROL::StepFactory< Real >
oCROL::StepState< Real >State for step class. Will be used for restarts
oCTestMulti< Real >
oCROL::TestProblem< Real >
oCTestSingle< Real >
oCTeuchosBatchManager
oCROL::TimeStamp< typename >Contains local time step information
oCROL::TimeStamp< Real >
oCROL::TrustRegion< Real >Provides interface for and implements trust-region subproblem solvers
oCROL::TypeCaster< Real, Element >
oCROL::TypeCaster< double, float >
oCROL::TypeCaster< Real, std::complex< Real > >
oCUnaryFunction
oCROL::Vector< Real >Defines the linear algebra or vector space interface
oCROL::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
oCROL::details::VectorClone< Real >
oCROL::VectorClone< Real >
oCROL::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
oCROL::details::VectorCloneMap< Real, KeyType >
oCROL::details::VectorCloneMap< Real >
oCROL::VectorCloneMap< Real >
oCROL::VectorFunctionCalls< Ordinal >
oCROL::details::VectorWorkspace< Real >::VectorKey
oCROL::details::VectorWorkspace< Real >::VectorStack
oCROL::details::VectorWorkspace< Real >
oCROL::VectorWorkspaceProvides a "smart" cloning manager to be used a member variable in a class and called in the member function of the same class
oCROL::VectorWorkspace< Real >
oCROL::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
oCROL::WrappedVector< Real >
\CZakharov< Real >