 ROL::Algorithm | Provides an interface to run optimization algorithms |
 ROL::AlgorithmState< Real > | State for algorithm class. Will be used for restarts |
 ROL::BatchManager< Real > | |
  ROL::EpetraBatchManager< Real > | |
   ROL::StdEpetraBatchManager< Real > | |
 BoundaryValueProblem< Real > | Compute the constraint vector -u'' + exp(u) - z with natural boundary conditions |
 ROL::BoundConstraint< Real > | Provides the interface to apply upper and lower bound constraints |
  BoundConstraint_BurgersControl< Real > | |
  BoundConstraint_PoissonControl< Real > | |
  BoundConstraint_PoissonInversion< Real > | |
  ROL::CVaRBoundConstraint< Real > | |
  ROL::StdBoundConstraint< Real > | |
  ROL::ZOO::BoundConstraint_DiodeCircuit< Real > | Bound constraints on optimization parameters |
 ROL::Bundle< Real > | Provides the interface for and implments a bundle |
 ROL::Constraints< Real > | |
 ROL::DefaultAlgorithm< Real > | |
 DiffU | |
 ROL::Distribution< Real > | |
 ROL::EqualityConstraint< Real > | Defines the equality constraint operator interface |
  Normalization_Constraint< Real > | |
  Normalization_Constraint< Real > | |
  Normalization_Constraint< Real > | |
  ROL::EqualityConstraint_SimOpt< Real > | Defines the equality constraint operator interface for simulation-based optimization |
   EqualityConstraint_BurgersControl< Real > | |
   EqualityConstraint_BurgersControl< Real > | |
   EqualityConstraint_BurgersControl< Real > | |
   ROL::ParametrizedEqualityConstraint_SimOpt< Real > | |
  ROL::ParametrizedEqualityConstraint< Real > | |
  ROL::ZOO::EqualityConstraint_SimpleEqConstrained< Real, XPrim, XDual, CPrim, CDual > | Equality constraints c_i(x) = 0, where: c1(x) = x1^2+x2^2+x3^2+x4^2+x5^2 - 10 c2(x) = x2*x3-5*x4*x5 c3(x) = x1^3 + x2^3 + 1 |
 Example_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 \]
|
 ExpU | |
 FiniteDifference< Real > | |
 FunctionZakharov< ScalarT > | |
 FunctionZakharov< GradType > | |
 FunctionZakharov< HessVecType > | |
 FunctionZakharov< Real > | |
 InnerProductMatrix< Real > | |
  InnerProductMatrixSolver< Real > | This class adds a solve method |
 ROL::Krylov< Real > | Provides definitions for Krylov solvers |
  ROL::ConjugateGradients< Real > | Provides definitions of the Conjugate Gradient solver |
  ROL::ConjugateResiduals< Real > | Provides definition of the Conjugate Residual solver |
 Lagrange< Real > | |
 ROL::LinearOperator< Real > | Provides the interface to apply a linear operator |
  ROL::PrimalDualHessian< Real > | |
  ROL::PrimalDualPreconditioner< Real > | |
  ROL::ProjectedHessian< Real > | |
  ROL::ProjectedPreconditioner< Real > | |
 ROL::LineSearch< Real > | Provides interface for and implements line searches |
  ROL::BackTracking< Real > | Implements a simple back tracking line search |
  ROL::Bisection< Real > | Implements a bisection line search |
  ROL::Brents< Real > | Implements a Brent's method line search |
  ROL::CubicInterp< Real > | Implements cubic interpolation back tracking line search |
  ROL::GoldenSection< Real > | Implements a golden section line search |
  ROL::IterationScaling< Real > | Provides an implementation of iteration scaled line search |
  ROL::PathBasedTargetLevel< Real > | Provides an implementation of path-based target leve line search |
 MinusZ | |
 ROL::MultiVector< Real > | Provides a container and operations on multiple ROL vectors for use with other Trilinos packages which require multivectors |
  ROL::MultiVectorDefault< Real > | Default implementation of the ROL::MultiVector container class |
 NodalBasis< Real > | |
 ROL::Objective< Real > | Provides the interface to evaluate objective functions |
  GradientEnabler< Real > | |
  GradientEnabler< Real > | |
  HessianEnabler< Real > | |
  HessianEnabler< Real > | |
  Objective_BurgersControl< Real > | |
  Objective_GrossPitaevskii< Real > | |
  Objective_GrossPitaevskii< Real > | |
  Objective_GrossPitaevskii< Real > | |
  Objective_PoissonInversion< Real > | |
  ObjectiveAD< Real > | |
  ObjectiveEnabler< Real > | |
  ROL::Minimax1< Real > | |
  ROL::Minimax2< Real > | |
  ROL::Minimax3< Real > | |
  ROL::Objective_SimOpt< Real > | Provides the interface to evaluate simulation-based objective functions |
   Objective_BurgersControl< Real > | |
   Objective_BurgersControl< Real > | |
   Objective_BurgersControl< Real > | |
   ROL::ParametrizedObjective_SimOpt< Real > | |
  ROL::ParametrizedObjective< Real > | |
   ROL::ParametrizedObjective_SimOpt< Real > | |
   ROL::Reduced_ParametrizedObjective_SimOpt< Real > | |
  ROL::ProjectedObjective< Real > | |
  ROL::Reduced_Objective_SimOpt< Real > | Provides the interface to evaluate simulation-based reduced objective functions |
  ROL::RiskAverseObjective< Real > | |
  ROL::RiskNeutralObjective< Real > | |
  ROL::ZOO::Objective_Beale< Real > | Beale's function |
  ROL::ZOO::Objective_BVP< Real > | The discrete boundary value problem |
  ROL::ZOO::Objective_DiodeCircuit< Real > | The diode circuit problem |
  ROL::ZOO::Objective_FreudensteinRoth< Real > | Freudenstein and Roth's function |
  ROL::ZOO::Objective_HS1< Real > | W. Hock and K. Schittkowski 1st test function |
  ROL::ZOO::Objective_HS2< Real > | W. Hock and K. Schittkowski 2nd test function |
  ROL::ZOO::Objective_HS25< Real > | W. Hock and K. Schittkowski 25th test function |
  ROL::ZOO::Objective_HS3< Real > | W. Hock and K. Schittkowski 3rd test function |
  ROL::ZOO::Objective_HS38< Real > | W. Hock and K. Schittkowski 38th test function |
  ROL::ZOO::Objective_HS4< Real > | W. Hock and K. Schittkowski 4th test function |
  ROL::ZOO::Objective_HS45< Real > | W. Hock and K. Schittkowski 45th test function |
  ROL::ZOO::Objective_HS5< Real > | W. Hock and K. Schittkowski 5th test function |
  ROL::ZOO::Objective_LeastSquares< Real > | Least squares function |
  ROL::ZOO::Objective_PoissonControl< Real > | Poisson distributed control |
  ROL::ZOO::Objective_PoissonInversion< Real > | Poisson material inversion |
  ROL::ZOO::Objective_Powell< Real > | Powell's badly scaled function |
  ROL::ZOO::Objective_Rosenbrock< Real, XPrim, XDual > | Rosenbrock's function |
  ROL::ZOO::Objective_SimpleEqConstrained< Real, XPrim, XDual > | Objective function: f(x) = exp(x1*x2*x3*x4*x5) + 0.5*(x1^3+x2^3+1)^2 |
  ROL::ZOO::Objective_SumOfSquares< Real > | Sum of squares function |
  ROL::ZOO::Objective_Zakharov< Real > | Zakharov function |
  Zakharov< Real > | |
  Zakharov_Sacado_Objective< Real > | |
 ROL::PositiveFunction< Real > | |
  ROL::AbsoluteValue< Real > | |
  ROL::PlusFunction< Real > | |
 QuadraticTracking< Real > | Objective to minimize
\[ \frac{1}{2} \|u-u_\text{targ}|\^2 + \frac{\gamma}{2}\|z\|^2 \]
|
 ROL::Quadrature< Real > | |
 ROL::removeSpecialCharacters | |
 ROL::RiskMeasure< Real > | |
  ROL::CVaR< Real > | |
  ROL::ExpectationQuad< Real > | |
   ROL::SmoothCVaRQuad< Real > | |
  ROL::ExpUtility< Real > | |
  ROL::MeanDeviation< Real > | |
  ROL::MeanDeviationFromTarget< Real > | |
  ROL::MeanVariance< Real > | |
  ROL::MeanVarianceFromTarget< Real > | |
 ROL::ROLBurkardtRules | Providing integration rules, created by John Burkardt, Scientific Computing, Florida State University, modified and redistributed by D. Kouri |
 Sacado_EqualityConstraint_SimOpt | |
  BVP_Constraint< Real, BoundaryValueProblem > | Inherit and add method for applying the inverse partial constraint Jacobian and its adjoint |
 ROL::SampleGenerator< Real > | |
  ROL::MonteCarloGenerator< Real > | |
  ROL::SparseGridGenerator< Real > | |
  ROL::UserInputGenerator< Real > | |
 ROL::SandiaRules | |
  ROL::SandiaRules2 | |
 ROL::SandiaSGMGA | |
 ROL::Secant< Real > | Provides interface for and implements limited-memory secant operators |
  ROL::BarzilaiBorwein< Real > | Provides definitions for Barzilai-Borwein operators |
  ROL::lBFGS< Real > | Provides definitions for limited-memory BFGS operators |
  ROL::lDFP< Real > | Provides definitions for limited-memory DFP operators |
  ROL::lSR1< Real > | Provides definitions for limited-memory SR1 operators |
 ROL::SecantState< Real > | |
 ROL::sgmga | |
 ROL::SparseGridInfo | |
 ROL::StatusTest< Real > | Provides an interface to check status of optimization algorithms |
  ROL::BundleStatusTest< Real > | |
  ROL::StatusTestSQP< Real > | |
  StatusTest_PDAS< Real > | |
 ROL::Step< Real > | Provides the interface to compute optimization steps |
  ROL::BundleStep< Real > | Provides the interface to compute bundle trust-region steps |
  ROL::CompositeStepSQP< Real > | Implements the computation of optimization steps with composite-step trust-region SQP methods |
  ROL::LineSearchStep< Real > | Provides the interface to compute optimization steps with line search |
  ROL::PrimalDualActiveSetStep< Real > | Implements the computation of optimization steps with the Newton primal-dual active set method |
  ROL::TrustRegionStep< Real > | Provides the interface to compute optimization steps with trust regions |
 ROL::StepState< Real > | State for step class. Will be used for restarts |
 ROL::TrustRegion< Real > | Provides interface for and implements trust-region subproblem solvers |
  ROL::CauchyPoint< Real > | Provides interface for the Cauchy point trust-region subproblem solver |
  ROL::DogLeg< Real > | Provides interface for dog leg trust-region subproblem solver |
  ROL::DoubleDogLeg< Real > | Provides interface for the double dog leg trust-region subproblem solver |
  ROL::TruncatedCG< Real > | Provides interface for truncated CG trust-region subproblem solver |
 ROL::Vector< Real > | Defines the linear algebra or vector space interface |
  ConDualStdVector< Real, Element > | |
  ConDualStdVector< Real, Element > | |
  ConDualStdVector< Real, Element > | |
  ConStdVector< Real, Element > | |
  ConStdVector< Real, Element > | |
  ConStdVector< Real, Element > | |
  OptDualStdVector< Real, Element > | |
  OptDualStdVector< Real, Element > | |
  OptDualStdVector< Real, Element > | |
  OptDualStdVector< Real, Element > | |
  OptStdVector< Real, Element > | |
  OptStdVector< Real, Element > | |
  OptStdVector< Real, Element > | |
  OptStdVector< Real, Element > | |
  ROL::CArrayVector< Real, Element > | Provides the C array implementation of the ROL::Vector interface for use with NumPy->C Array passing by pointer. This class in intended to be used with the Python ROL interface |
  ROL::CVaRVector< Real > | |
  ROL::StdVector< Real, Element > | Provides the std::vector implementation of the ROL::Vector interface |
  ROL::Vector_SimOpt< Real > | Defines the linear algebra or vector space interface for simulation-based optimization |