►NROL | |
►NInteriorPoint | |
CCompositeConstraint | Has both inequality and equality constraints. Treat inequality constraint as equality with slack variable |
CPenalizedObjective | |
CPrimalDualResidual | Express the Primal-Dual Interior Point gradient as an equality constraint |
CPrimalDualSymmetrizer | |
►NZOO | |
CEqualityConstraint_HS32 | |
CEqualityConstraint_SimpleEqConstrained | 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 |
CInequalityConstraint_HS24 | |
CInequalityConstraint_HS29 | |
CInequalityConstraint_HS32 | |
CObjective_Beale | Beale's function |
CObjective_BVP | The discrete boundary value problem |
CObjective_DiodeCircuit | The diode circuit problem |
CObjective_FreudensteinRoth | Freudenstein and Roth's function |
CObjective_HS1 | W. Hock and K. Schittkowski 1st test function |
CObjective_HS2 | W. Hock and K. Schittkowski 2nd test function |
CObjective_HS24 | |
CObjective_HS25 | W. Hock and K. Schittkowski 25th test function |
CObjective_HS29 | |
CObjective_HS3 | W. Hock and K. Schittkowski 3rd test function |
CObjective_HS32 | |
CObjective_HS38 | W. Hock and K. Schittkowski 38th test function |
CObjective_HS4 | W. Hock and K. Schittkowski 4th test function |
CObjective_HS45 | W. Hock and K. Schittkowski 45th test function |
CObjective_HS5 | W. Hock and K. Schittkowski 5th test function |
CObjective_LeastSquares | Least squares function |
CObjective_PoissonControl | Poisson distributed control |
CObjective_PoissonInversion | Poisson material inversion |
CObjective_Powell | Powell's badly scaled function |
CObjective_Rosenbrock | Rosenbrock's function |
CObjective_SimpleEqConstrained | Objective function: f(x) = exp(x1*x2*x3*x4*x5) + 0.5*(x1^3+x2^3+1)^2 |
CObjective_SumOfSquares | Sum of squares function |
CObjective_Zakharov | Zakharov function |
CAbsoluteValue | |
CAlgorithm | Provides an interface to run optimization algorithms |
CAlgorithmState | State for algorithm class. Will be used for restarts |
CArcsine | |
CAtomVector | Provides the std::vector implementation of the ROL::Vector interface |
CAugmentedLagrangian | Provides the interface to evaluate the augmented Lagrangian |
CAugmentedLagrangianStep | Provides the interface to compute augmented Lagrangian steps |
CBackTracking | Implements a simple back tracking line search |
CBarzilaiBorwein | Provides definitions for Barzilai-Borwein operators |
CBatchManager | |
CBeta | |
CBisection | Implements a bisection line search |
CBlockOperator | Provides the interface to apply a block operator to a partitioned vector |
CBlockOperator2 | |
►CBoundConstraint | Provides the interface to apply upper and lower bound constraints |
CActive | |
CLowerBinding | |
CPruneBinding | |
CUpperBinding | |
CBoundConstraint_SimOpt | |
CBoundInequalityConstraint | Provides an implementation for bound inequality constraints |
CBPOEObjective | |
CBrents | Implements a Brent's method line search |
CBundle | Provides the interface for and implments a bundle |
CBundle_TT | Provides the interface for and implements a bundle. The semidefinite quadratic subproblem is solved using TT algorithm by Antonio Frangioni (1996) |
CBundleStatusTest | |
CBundleStep | Provides the interface to compute bundle trust-region steps |
CCArrayVector | 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 |
CCauchy | |
CCauchyPoint | Provides interface for the Cauchy point trust-region subproblem solver |
CCDFObjective | |
CCompositeStep | Implements the computation of optimization steps with composite-step trust-region methods |
CConjugateGradients | Provides definitions of the Conjugate Gradient solver |
CConjugateResiduals | Provides definition of the Conjugate Residual solver |
CConstraints | |
CConstraintStatusTest | Provides an interface to check status of optimization algorithms for problems with equality constraints |
CCplxStdVector | Variant on ROL::StdVector with complex entries. Perhaps this can be accomplished with partial template specialization of ROL::StdVector instead? |
CCubicInterp | Implements cubic interpolation back tracking line search |
CCVaR | |
CDiagonalOperator | Provides the interface to apply a diagonal operator which acts like elementwise multiplication when apply() is used and elementwise division when applyInverse() is used |
CDirac | |
CDistribution | |
CDogLeg | Provides interface for dog leg trust-region subproblem solver |
CDoubleDogLeg | Provides interface for the double dog leg trust-region subproblem solver |
CDualAtomVector | |
CDualProbabilityVector | |
CDualScaledStdVector | Provides the std::vector implementation of the ROL::Vector interface that handles scalings in the inner product. Also see ROL::PrimalScaledStdVector |
CEqualityConstraint | Defines the equality constraint operator interface |
CEqualityConstraint_SimOpt | Defines the equality constraint operator interface for simulation-based optimization |
CExpectationQuad | |
CExponential | |
CExpUtility | |
CGamma | |
CGaussian | |
CGMRES | Preconditioned GMRES solver |
CGoldenSection | Implements a golden section line search |
CHMCR | |
CHMCRObjective | |
CInequalityConstraint | Provides a unique argument for inequality constraints, which otherwise behave exactly as equality constraints |
CInteriorPointStep | |
CIterationScaling | Provides an implementation of iteration scaled line search |
CKLDivergence | |
CKrylov | Provides definitions for Krylov solvers |
CKumaraswamy | |
CLaplace | |
ClBFGS | Provides definitions for limited-memory BFGS operators |
ClDFP | Provides definitions for limited-memory DFP operators |
CLinearCombinationObjective | |
CLinearObjective | Provides the interface to evaluate linear objective functions |
CLinearOperator | Provides the interface to apply a linear operator |
CLineSearch | Provides interface for and implements line searches |
CLineSearchStep | Provides the interface to compute optimization steps with line search |
CLogBarrierObjective | Log barrier objective for interior point methods |
CLogExponentialQuadrangle | |
CLogistic | |
CLogQuantileQuadrangle | |
CLowerBoundInequalityConstraint | Provides an implementation for lower bound inequality constraints |
ClSR1 | Provides definitions for limited-memory SR1 operators |
CMeanDeviation | |
CMeanDeviationFromTarget | |
CMeanVariance | |
CMeanVarianceFromTarget | |
CMinimax1 | |
CMinimax2 | |
CMinimax3 | |
CMixedQuantileQuadrangle | |
CMomentObjective | |
CMonteCarloGenerator | |
CMoreauYosidaCVaR | |
CMoreauYosidaPenalty | Provides the interface to evaluate the Moreau-Yosida penalty function |
CMoreauYosidaPenaltyStep | Implements the computation of optimization steps using Moreau-Yosida regularized bound constraints |
CMultiVector | Provides a container and operations on multiple ROL vectors for use with other Trilinos packages which require multivectors |
CMultiVectorDefault | Default implementation of the ROL::MultiVector container class |
CObjective | Provides the interface to evaluate objective functions |
CObjective_SimOpt | Provides the interface to evaluate simulation-based objective functions |
►CObjectiveFromBoundConstraint | Create a logarithmic penalty objective from upper and lower bound vectors |
CLogarithmLower | |
CLogarithmUpper | |
CReciprocalLower | |
CReciprocalUpper | |
COptimizationProblem | |
CParabolic | |
CParametrizedEqualityConstraint | |
CParametrizedEqualityConstraint_SimOpt | |
CParametrizedObjective | |
CParametrizedObjective_SimOpt | |
CPartitionedVector | Defines the linear algebra of vector space on a generic partitioned vector |
CPathBasedTargetLevel | Provides an implementation of path-based target leve line search |
CPenalizedObjective | Adds barrier term to generic objective |
CPlusFunction | |
CPointwiseCDFObjective | |
CPositiveFunction | |
CPrimalAtomVector | |
CPrimalDualActiveSetStep | Implements the computation of optimization steps with the Newton primal-dual active set method |
CPrimalDualHessian | |
CPrimalDualPreconditioner | |
CPrimalProbabilityVector | |
CPrimalScaledStdVector | Provides the std::vector implementation of the ROL::Vector interface that handles scalings in the inner product. Also see ROL::DualScaledStdVector |
CProbabilityVector | Provides the std::vector implementation of the ROL::Vector interface |
CProjectedHessian | |
CProjectedObjective | |
CProjectedPreconditioner | |
CQuantileQuadrangle | |
CQuantileRadiusQuadrangle | |
CRaisedCosine | |
CReduced_Objective_SimOpt | Provides the interface to evaluate simulation-based reduced objective functions |
CReduced_ParametrizedObjective_SimOpt | |
CremoveSpecialCharacters | |
CRiskAverseObjective | |
CRiskBoundConstraint | |
CRiskMeasure | |
CRiskNeutralObjective | |
CRiskVector | |
CSampleGenerator | |
CScalarLinearEqualityConstraint | This equality constraint defines an affine hyperplane |
CSecant | Provides interface for and implements limited-memory secant operators |
CSecantState | |
CSmale | |
CSROMGenerator | |
CSROMVector | Provides the std::vector implementation of the ROL::Vector interface |
CStatusTest | Provides an interface to check status of optimization algorithms |
CStatusTestFactory | |
CStdBoundConstraint | |
CStdTeuchosBatchManager | |
CStdVector | Provides the std::vector implementation of the ROL::Vector interface |
CStep | Provides the interface to compute optimization steps |
CStepFactory | |
CStepState | State for step class. Will be used for restarts |
CStochasticProblem | |
CTeuchosBatchManager | |
CTriangle | |
CTruncatedCG | Provides interface for truncated CG trust-region subproblem solver |
CTruncatedExponential | |
CTruncatedGaussian | |
CTruncatedMeanQuadrangle | |
CTrustRegion | Provides interface for and implements trust-region subproblem solvers |
CTrustRegionStep | Provides the interface to compute optimization steps with trust regions |
CUniform | |
CUpperBoundInequalityConstraint | Provides an implementation for upper bound inequality constraints |
CUserInputGenerator | |
CVector | Defines the linear algebra or vector space interface |
CVector_SimOpt | Defines the linear algebra or vector space interface for simulation-based optimization |
CBoundConstraint_BurgersControl | |
CBurgersFEM | |
CConDualStdVector | |
CConStdVector | |
CDyadicOperator | |
CEqualityConstraint_BurgersControl | |
CExample_Objective | 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 \] |
CFiniteDifference | |
CFunctionZakharov | |
CH1BoundConstraint | |
CH1VectorBatchManager | |
CH1VectorDual | |
CH1VectorPrimal | |
CIdentity | |
CInnerProductMatrix | |
CInnerProductMatrixSolver | This class adds a solve method |
CL2BoundConstraint | |
CL2VectorBatchManager | |
CL2VectorDual | |
CL2VectorPrimal | |
CLagrange | |
CNodalBasis | |
CNormalization_Constraint | |
CNullOperator | |
CObjective_BurgersControl | |
CObjective_GrossPitaevskii | |
CObjective_PoissonInversion | |
COptDualStdVector | |
COptStdVector | |
CStatusTest_PDAS | |
CTridiagonalToeplitzOperator | |
CZakharov | |
CZakharov_Sacado_Objective |