ROL
|
Namespaces | |
Exception | |
Finite_Difference_Arrays | |
InteriorPoint | |
Refactor | |
StringList | |
ZOO | |
Classes | |
class | AbsoluteValue |
class | Algorithm |
Provides an interface to run optimization algorithms. More... | |
struct | AlgorithmState |
State for algorithm class. Will be used for restarts. More... | |
class | Arcsine |
class | AtomVector |
Provides the std::vector implementation of the ROL::Vector interface. More... | |
class | AugmentedLagrangian |
Provides the interface to evaluate the augmented Lagrangian. More... | |
class | AugmentedLagrangian_SimOpt |
Provides the interface to evaluate the SimOpt augmented Lagrangian. More... | |
class | AugmentedLagrangianStep |
Provides the interface to compute augmented Lagrangian steps. More... | |
class | BackTracking |
Implements a simple back tracking line search. More... | |
class | BarzilaiBorwein |
Provides definitions for Barzilai-Borwein operators. More... | |
class | BatchManager |
class | BatchStdVector |
Provides the std::vector implementation of the ROL::Vector interface. More... | |
class | Beta |
class | Bisection |
Implements a bisection line search. More... | |
class | BlockOperator |
Provides the interface to apply a block operator to a partitioned vector. More... | |
class | BlockOperator2 |
class | BoundConstraint |
Provides the interface to apply upper and lower bound constraints. More... | |
class | BoundConstraint_Partitioned |
A composite composite BoundConstraint formed from bound constraints on subvectors of a PartitionedVector. More... | |
class | BoundConstraint_SimOpt |
class | BoundInequalityConstraint |
Provides an implementation for bound inequality constraints. More... | |
class | BPOEObjective |
class | Brents |
Implements a Brent's method line search. More... | |
class | Bundle |
Provides the interface for and implments a bundle. More... | |
class | Bundle_TT |
Provides the interface for and implements a bundle. The semidefinite quadratic subproblem is solved using TT algorithm by Antonio Frangioni (1996). More... | |
class | BundleStatusTest |
class | BundleStep |
Provides the interface to compute bundle trust-region steps. More... | |
class | CArrayVector |
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. More... | |
class | Cauchy |
class | CauchyPoint |
Provides interface for the Cauchy point trust-region subproblem solver. More... | |
class | CDFObjective |
class | ChebyshevKusuoka |
Provides an interface for the Chebyshev-Kusuoka risk measure. More... | |
class | Chi2Divergence |
Provides an interface for the chi-squared-divergence distributionally robust expectation. More... | |
class | CoherentExpUtility |
Provides the interface for the coherent entropic risk measure. More... | |
class | ColemanLiModel |
Provides the interface to evaluate interior trust-region model functions from the Coleman-Li bound constrained trust-region algorithm. More... | |
class | CompositeConstraint |
Has both inequality and equality constraints. Treat inequality constraint as equality with slack variable. More... | |
class | CompositeEqualityConstraint_SimOpt |
Defines a composite equality constraint operator interface for simulation-based optimization. More... | |
class | CompositeObjective |
Provides the interface to evaluate composite objective functions. More... | |
class | CompositeObjective_SimOpt |
Provides the interface to evaluate simulation-based composite objective functions. More... | |
class | CompositeStep |
Implements the computation of optimization steps with composite-step trust-region methods. More... | |
class | ConjugateGradients |
Provides definitions of the Conjugate Gradient solver. More... | |
class | ConjugateResiduals |
Provides definition of the Conjugate Residual solver. More... | |
class | Constraints |
class | ConstraintStatusTest |
Provides an interface to check status of optimization algorithms for problems with equality constraints. More... | |
class | ConvexCombinationRiskMeasure |
Provides an interface for a convex combination of risk measures. More... | |
class | CubicInterp |
Implements cubic interpolation back tracking line search. More... | |
class | CVaR |
Provides an interface for a convex combination of the expected value and the conditional value-at-risk. More... | |
class | DiagonalOperator |
Provides the interface to apply a diagonal operator which acts like elementwise multiplication when apply() is used and elementwise division when applyInverse() is used. More... | |
class | Dirac |
class | Distribution |
class | DogLeg |
Provides interface for dog leg trust-region subproblem solver. More... | |
class | DoubleDogLeg |
Provides interface for the double dog leg trust-region subproblem solver. More... | |
class | DualAtomVector |
class | DualProbabilityVector |
class | DualScaledStdVector |
Provides the std::vector implementation of the ROL::Vector interface that handles scalings in the inner product. Also see ROL::PrimalScaledStdVector. More... | |
class | ElementwiseVector |
Intermediate abstract class which does not require users implements plus, set, scale, axpy, norm, dot, or zero if they implement the three elementwise functions: applyUnary, applyBinary, and reduce. More... | |
class | EqualityConstraint |
Defines the equality constraint operator interface. More... | |
class | EqualityConstraint_Partitioned |
Allows composition of equality constraints. More... | |
class | EqualityConstraint_SimOpt |
Defines the equality constraint operator interface for simulation-based optimization. More... | |
class | ExpectationQuad |
Provides a general interface for risk measures generated through the expectation risk quadrangle. More... | |
class | Exponential |
class | ExpUtility |
Provides an interface for the entropic risk. More... | |
class | FDivergence |
Provides a general interface for the F-divergence distributionally robust expectation. More... | |
class | Gamma |
class | Gaussian |
class | GMRES |
Preconditioned GMRES solver. More... | |
class | GoldenSection |
Implements a golden section line search. More... | |
class | GradientStep |
Provides the interface to compute optimization steps with the gradient descent method globalized using line search. More... | |
class | HMCR |
Provides an interface for a convex combination of the expected value and the higher moment coherent risk measure. More... | |
class | HMCRObjective |
class | InequalityConstraint |
Provides a unique argument for inequality constraints, which otherwise behave exactly as equality constraints. More... | |
class | InteriorPointStep |
class | IterationScaling |
Provides an implementation of iteration scaled line search. More... | |
class | KelleySachsModel |
Provides the interface to evaluate projected trust-region model functions from the Kelley-Sachs bound constrained trust-region algorithm. More... | |
class | KLDivergence |
Provides an interface for the Kullback-Leibler distributionally robust expectation. More... | |
class | Krylov |
Provides definitions for Krylov solvers. More... | |
class | Kumaraswamy |
class | Laplace |
class | lBFGS |
Provides definitions for limited-memory BFGS operators. More... | |
class | lDFP |
Provides definitions for limited-memory DFP operators. More... | |
class | LinearCombinationObjective |
class | LinearObjective |
Provides the interface to evaluate linear objective functions. More... | |
class | LinearOperator |
Provides the interface to apply a linear operator. More... | |
class | LineSearch |
Provides interface for and implements line searches. More... | |
class | LineSearchStep |
Provides the interface to compute optimization steps with line search. More... | |
class | LogBarrierObjective |
Log barrier objective for interior point methods. More... | |
class | LogExponentialQuadrangle |
Provides an interface for the entropic risk using the expectation risk quadrangle. More... | |
class | Logistic |
class | LogQuantileQuadrangle |
Provides an interface for the conditioanl entropic risk using the expectation risk quadrangle. More... | |
class | LowerBoundInequalityConstraint |
Provides an implementation for lower bound inequality constraints. More... | |
class | lSR1 |
Provides definitions for limited-memory SR1 operators. More... | |
class | MeanDeviation |
Provides an interface for the mean plus a sum of arbitrary order deviations. More... | |
class | MeanDeviationFromTarget |
Provides an interface for the mean plus a sum of arbitrary order deviations from targets. More... | |
class | MeanVariance |
Provides an interface for the mean plus a sum of arbitrary order variances. More... | |
class | MeanVarianceFromTarget |
Provides an interface for the mean plus a sum of arbitrary order variances from targets. More... | |
class | MeanVarianceQuadrangle |
Provides an interface for the mean plus variance risk measure using the expectation risk quadrangle. More... | |
class | Minimax1 |
class | Minimax2 |
class | Minimax3 |
class | MixedQuantileQuadrangle |
Provides an interface for a convex combination of conditional value-at-risks. More... | |
class | MomentObjective |
class | MonteCarloGenerator |
class | MoreauYosidaCVaR |
Provides an interface for a smooth approximation of the conditional value-at-risk. More... | |
class | MoreauYosidaPenalty |
Provides the interface to evaluate the Moreau-Yosida penalty function. More... | |
class | MoreauYosidaPenaltyStep |
Implements the computation of optimization steps using Moreau-Yosida regularized bound constraints. More... | |
class | MultiVector |
Provides a container and operations on multiple ROL vectors for use with other Trilinos packages which require multivectors. More... | |
class | MultiVectorDefault |
Default implementation of the ROL::MultiVector container class. More... | |
class | NewtonKrylovStep |
Provides the interface to compute optimization steps with projected inexact Newton's method using line search. More... | |
class | NewtonStep |
Provides the interface to compute optimization steps with Newton's method globalized using line search. More... | |
class | NonlinearCGStep |
Provides the interface to compute optimization steps with nonlinear CG. More... | |
class | NonlinearLeastSquaresObjective |
Provides the interface to evaluate nonlinear least squares objective functions. More... | |
class | Objective |
Provides the interface to evaluate objective functions. More... | |
class | Objective_SimOpt |
Provides the interface to evaluate simulation-based objective functions. More... | |
class | ObjectiveFromBoundConstraint |
Create a penalty objective from upper and lower bound vectors. More... | |
class | OptimizationProblem |
class | Parabolic |
class | Parametrize |
Provides the mix-in interface for making objects parametrized. More... | |
class | ParametrizedCompositeObjective |
Provides the interface to evaluate parametrized composite objective functions. More... | |
class | ParametrizedCompositeObjective_SimOpt |
class | ParametrizedEqualityConstraint |
class | ParametrizedEqualityConstraint_SimOpt |
class | ParametrizedObjective |
class | ParametrizedObjective_SimOpt |
class | ParametrizedStdObjective |
Specializes the ROL::Objective interface for objective functions that operate on ROL::StdVector's. More... | |
class | PartitionedVector |
Defines the linear algebra of vector space on a generic partitioned vector. More... | |
class | PathBasedTargetLevel |
Provides an implementation of path-based target leve line search. More... | |
class | PenalizedObjective |
Adds barrier term to generic objective. More... | |
class | PlusFunction |
class | PointwiseCDFObjective |
class | PositiveFunction |
class | PrimalAtomVector |
class | PrimalDualActiveSetStep |
Implements the computation of optimization steps with the Newton primal-dual active set method. More... | |
class | PrimalProbabilityVector |
class | PrimalScaledStdVector |
Provides the std::vector implementation of the ROL::Vector interface that handles scalings in the inner product. Also see ROL::DualScaledStdVector. More... | |
class | ProbabilityVector |
Provides the std::vector implementation of the ROL::Vector interface. More... | |
class | ProjectedNewtonKrylovStep |
Provides the interface to compute optimization steps with projected inexact ProjectedNewton's method using line search. More... | |
class | ProjectedNewtonStep |
Provides the interface to compute optimization steps with projected Newton's method using line search. More... | |
class | ProjectedObjective |
class | ProjectedSecantStep |
Provides the interface to compute optimization steps with projected secant method using line search. More... | |
class | QuadraticObjective |
Provides the interface to evaluate quadratic objective functions. More... | |
class | QuadraticPenalty |
Provides the interface to evaluate the quadratic constraint penalty. More... | |
class | QuadraticPenalty_SimOpt |
Provides the interface to evaluate the quadratic SimOpt constraint penalty. More... | |
class | QuantileQuadrangle |
Provides an interface for a convex combination of the expected value and the conditional value-at-risk using the expectation risk quadrangle. More... | |
class | QuantileRadiusQuadrangle |
class | RaisedCosine |
class | Reduced_AugmentedLagrangian_SimOpt |
Provides the interface to evaluate the reduced SimOpt augmented Lagrangian. More... | |
class | Reduced_Objective_SimOpt |
class | Reduced_ParametrizedObjective_SimOpt |
struct | removeSpecialCharacters |
class | RiskAverseObjective |
class | RiskBoundConstraint |
class | RiskMeasure |
Provides the interface to implement risk measures. More... | |
class | RiskNeutralObjective |
class | RiskVector |
class | SampleGenerator |
class | ScalarLinearEqualityConstraint |
This equality constraint defines an affine hyperplane. More... | |
class | ScalarMinimizationLineSearch |
Implements line search methods that attempt to minimize the scalar function \(\phi(t) := f(x+ts)\). More... | |
class | Secant |
Provides interface for and implements limited-memory secant operators. More... | |
struct | SecantState |
class | SecantStep |
Provides the interface to compute optimization steps with a secant method. More... | |
class | SimulatedEqualityConstraint |
class | SimulatedObjective |
class | SimulatedObjectiveCVaR |
class | SimulatedVector |
Defines the linear algebra of a vector space on a generic partitioned vector where the individual vectors are distributed in batches defined by ROL::BatchManager. This is a batch-distributed version of ROL::PartitionedVector. More... | |
class | SlacklessObjective |
This class strips out the slack variables from objective evaluations to create the new objective \( F(x,s) = f(x) \). More... | |
class | Smale |
class | SmoothedWorstCaseQuadrangle |
Provides an interface for a smoothed version of the worst-case scenario risk measure using the expectation risk quadrangle. More... | |
class | SpectralRisk |
Provides an interface for spectral risk measures. More... | |
class | SROMGenerator |
class | SROMVector |
Provides the std::vector implementation of the ROL::Vector interface. More... | |
class | StatusTest |
Provides an interface to check status of optimization algorithms. More... | |
class | StatusTestFactory |
class | StdBoundConstraint |
class | StdObjective |
Specializes the ROL::Objective interface for objective functions that operate on ROL::StdVector's. More... | |
class | StdTeuchosBatchManager |
class | StdVector |
Provides the std::vector implementation of the ROL::Vector interface. More... | |
class | Step |
Provides the interface to compute optimization steps. More... | |
class | StepFactory |
struct | StepState |
State for step class. Will be used for restarts. More... | |
class | StochasticProblem |
class | SuperQuantileQuadrangle |
Provides an interface for the risk measure associated with the super quantile quadrangle. More... | |
class | TeuchosBatchManager |
class | Triangle |
class | TruncatedCG |
Provides interface for truncated CG trust-region subproblem solver. More... | |
class | TruncatedExponential |
class | TruncatedGaussian |
class | TruncatedMeanQuadrangle |
class | TrustRegion |
Provides interface for and implements trust-region subproblem solvers. More... | |
class | TrustRegionModel |
Provides the interface to evaluate trust-region model functions. More... | |
class | TrustRegionStep |
Provides the interface to compute optimization steps with trust regions. More... | |
struct | TypeCaster |
struct | TypeCaster< double, float > |
struct | TypeCaster< Real, std::complex< Real > > |
class | Uniform |
class | UpperBoundInequalityConstraint |
Provides an implementation for upper bound inequality constraints. More... | |
class | UserInputGenerator |
class | Vector |
Defines the linear algebra or vector space interface. More... | |
class | Vector_SimOpt |
Defines the linear algebra or vector space interface for simulation-based optimization. More... | |
Functions | |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< Vector< Real > > &a) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< const Vector< Real > > &a) |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< Vector< Real > > &a, const Teuchos::RCP< Vector< Real > > &b) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< const Vector< Real > > &a, const Teuchos::RCP< const Vector< Real > > &b) |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< Vector< Real > > &a, const Teuchos::RCP< Vector< Real > > &b, const Teuchos::RCP< Vector< Real > > &c) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< const Vector< Real > > &a, const Teuchos::RCP< const Vector< Real > > &b, const Teuchos::RCP< const Vector< Real > > &c) |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< Vector< Real > > &a, const Teuchos::RCP< Vector< Real > > &b, const Teuchos::RCP< Vector< Real > > &c, const Teuchos::RCP< Vector< Real > > &d) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreatePartitionedVector (const Teuchos::RCP< const Vector< Real > > &a, const Teuchos::RCP< const Vector< Real > > &b, const Teuchos::RCP< const Vector< Real > > &c, const Teuchos::RCP< const Vector< Real > > &d) |
template<class Real > | |
void | RandomizeVector (Vector< Real > &x, const Real &lower=0.0, const Real &upper=1.0) |
Fill a ROL::Vector with uniformly-distributed random numbers in the interval [lower,upper]. More... | |
template<class Real > | |
Teuchos::RCP< BoundConstraint< Real > > | CreateBoundConstraint_Partitioned (const Teuchos::RCP< BoundConstraint< Real > > &bnd1, const Teuchos::RCP< BoundConstraint< Real > > &bnd2) |
template<class Real > | |
Teuchos::RCP< EqualityConstraint< Real > > | CreateEqualityConstraintPartitioned (const Teuchos::RCP< EqualityConstraint< Real > > &con1, const Teuchos::RCP< EqualityConstraint< Real > > &con2) |
template<class Real > | |
Teuchos::RCP< EqualityConstraint< Real > > | CreateEqualityConstraintPartitioned (const Teuchos::RCP< EqualityConstraint< Real > > &con1, const Teuchos::RCP< EqualityConstraint< Real > > &con2, const Teuchos::RCP< EqualityConstraint< Real > > &con3) |
template<class Real > | |
Real | normL1 (const Vector< Real > &x) |
template<class Real , class Exponent > | |
Real | normLp (const Vector< Real > &x, Exponent p) |
template<class Real > | |
Real | normLinf (const Vector< Real > &x) |
template<class Real > | |
Teuchos::RCP< Krylov< Real > > | KrylovFactory (Teuchos::ParameterList &parlist) |
template<class Real > | |
Teuchos::RCP< LineSearch< Real > > | LineSearchFactory (Teuchos::ParameterList &parlist) |
template<class Real > | |
Teuchos::RCP< Secant< Real > > | getSecant (ESecant esec=SECANT_LBFGS, int L=10, int BBtype=1) |
template<class Real > | |
Teuchos::RCP< Secant< Real > > | SecantFactory (Teuchos::ParameterList &parlist) |
template<class Real > | |
Teuchos::RCP< TrustRegion< Real > > | TrustRegionFactory (Teuchos::ParameterList &parlist) |
std::string | ETrustRegionToString (ETrustRegion tr) |
int | isValidTrustRegion (ETrustRegion ls) |
Verifies validity of a TrustRegion enum. More... | |
ETrustRegion & | operator++ (ETrustRegion &type) |
ETrustRegion | operator++ (ETrustRegion &type, int) |
ETrustRegion & | operator-- (ETrustRegion &type) |
ETrustRegion | operator-- (ETrustRegion &type, int) |
ETrustRegion | StringToETrustRegion (std::string s) |
std::string | ETrustRegionModelToString (ETrustRegionModel tr) |
int | isValidTrustRegionModel (ETrustRegionModel ls) |
Verifies validity of a TrustRegionModel enum. More... | |
ETrustRegionModel & | operator++ (ETrustRegionModel &type) |
ETrustRegionModel | operator++ (ETrustRegionModel &type, int) |
ETrustRegionModel & | operator-- (ETrustRegionModel &type) |
ETrustRegionModel | operator-- (ETrustRegionModel &type, int) |
ETrustRegionModel | StringToETrustRegionModel (std::string s) |
std::string | ETrustRegionFlagToString (ETrustRegionFlag trf) |
std::string | EDistributionToString (EDistribution ed) |
int | isValidDistribution (EDistribution ed) |
EDistribution & | operator++ (EDistribution &type) |
EDistribution | operator++ (EDistribution &type, int) |
EDistribution & | operator-- (EDistribution &type) |
EDistribution | operator-- (EDistribution &type, int) |
EDistribution | StringToEDistribution (std::string s) |
template<class Real > | |
Teuchos::RCP< Distribution< Real > > | DistributionFactory (Teuchos::ParameterList &parlist) |
std::string | ERiskMeasureToString (ERiskMeasure ed) |
int | isValidRiskMeasure (ERiskMeasure ed) |
ERiskMeasure & | operator++ (ERiskMeasure &type) |
ERiskMeasure | operator++ (ERiskMeasure &type, int) |
ERiskMeasure & | operator-- (ERiskMeasure &type) |
ERiskMeasure | operator-- (ERiskMeasure &type, int) |
ERiskMeasure | StringToERiskMeasure (std::string s) |
template<class Real > | |
Teuchos::RCP< RiskMeasure< Real > > | RiskMeasureFactory (Teuchos::ParameterList &parlist) |
template<class Real > | |
void | RiskMeasureInfo (Teuchos::ParameterList &parlist, std::string &name, int &nStatistic, std::vector< Real > &lower, std::vector< Real > &upper, bool &isBoundActivated, const bool printToStream=false, std::ostream &outStream=std::cout) |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< Vector< Real > > &a, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< const Vector< Real > > &a, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< Vector< Real > > &a, const Teuchos::RCP< Vector< Real > > &b, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< const Vector< Real > > &a, const Teuchos::RCP< const Vector< Real > > &b, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< Vector< Real > > &a, const Teuchos::RCP< Vector< Real > > &b, const Teuchos::RCP< Vector< Real > > &c, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< const Vector< Real > > &a, const Teuchos::RCP< const Vector< Real > > &b, const Teuchos::RCP< const Vector< Real > > &c, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::RCP< Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< Vector< Real > > &a, const Teuchos::RCP< Vector< Real > > &b, const Teuchos::RCP< Vector< Real > > &c, const Teuchos::RCP< Vector< Real > > &d, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::RCP< const Vector< Real > > | CreateSimulatedVector (const Teuchos::RCP< const Vector< Real > > &a, const Teuchos::RCP< const Vector< Real > > &b, const Teuchos::RCP< const Vector< Real > > &c, const Teuchos::RCP< const Vector< Real > > &d, const Teuchos::RCP< BatchManager< Real > > &bman) |
template<class Real > | |
Teuchos::SerialDenseMatrix< int, Real > | computeDenseHessian (Objective< Real > &obj, const Vector< Real > &x) |
template<class Real > | |
Teuchos::SerialDenseMatrix< int, Real > | computeDotMatrix (const Vector< Real > &x) |
template<class Real > | |
std::vector< std::vector< Real > > | computeEigenvalues (const Teuchos::SerialDenseMatrix< int, Real > &mat) |
template<class Real > | |
std::vector< std::vector< Real > > | computeGenEigenvalues (const Teuchos::SerialDenseMatrix< int, Real > &A, const Teuchos::SerialDenseMatrix< int, Real > &B) |
template<class Real > | |
Teuchos::SerialDenseMatrix< int, Real > | computeInverse (const Teuchos::SerialDenseMatrix< int, Real > &mat) |
template<class ParameterType > | |
void | setParameter (Teuchos::ParameterList &parlist, const std::vector< std::string > &location, const std::vector< std::string >::iterator iter, ParameterType value) |
void | tierParameterList (Teuchos::ParameterList &outList, const Teuchos::ParameterList &inList) |
Produce a heirarchical parameter list using the new names from a flat list of the old names. More... | |
template<class Real > | |
void | getTestObjectives (Teuchos::RCP< Objective< Real > > &obj, Teuchos::RCP< Vector< Real > > &x0, Teuchos::RCP< Vector< Real > > &x, const ETestObjectives test) |
template<class Real > | |
void | getTestObjectives (Teuchos::RCP< Objective< Real > > &obj, Teuchos::RCP< BoundConstraint< Real > > &con, Teuchos::RCP< Vector< Real > > &x0, Teuchos::RCP< Vector< Real > > &x, const ETestOptProblem test) |
template<class T > | |
std::string | NumberToString (T Number) |
template<class Real > | |
Real | ROL_EPSILON (void) |
Platform-dependent machine epsilon. More... | |
template<class Real > | |
Real | ROL_THRESHOLD (void) |
Tolerance for various equality tests. More... | |
template<class Real > | |
Real | ROL_OVERFLOW (void) |
Platform-dependent maximum double. More... | |
template<class Real > | |
Real | ROL_INF (void) |
template<class Real > | |
Real | ROL_NINF (void) |
template<class Real > | |
Real | ROL_UNDERFLOW (void) |
Platform-dependent minimum double. More... | |
std::string | removeStringFormat (std::string s) |
std::string | EStepToString (EStep tr) |
int | isValidStep (EStep ls) |
Verifies validity of a TrustRegion enum. More... | |
EStep & | operator++ (EStep &type) |
EStep | operator++ (EStep &type, int) |
EStep & | operator-- (EStep &type) |
EStep | operator-- (EStep &type, int) |
EStep | StringToEStep (std::string s) |
std::string | EBoundAlgorithmToString (EBoundAlgorithm tr) |
int | isValidBoundAlgorithm (EBoundAlgorithm d) |
Verifies validity of a Bound Algorithm enum. More... | |
EBoundAlgorithm & | operator++ (EBoundAlgorithm &type) |
EBoundAlgorithm | operator++ (EBoundAlgorithm &type, int) |
EBoundAlgorithm & | operator-- (EBoundAlgorithm &type) |
EBoundAlgorithm | operator-- (EBoundAlgorithm &type, int) |
EBoundAlgorithm | StringToEBoundAlgorithm (std::string s) |
std::string | EDescentToString (EDescent tr) |
int | isValidDescent (EDescent d) |
Verifies validity of a Secant enum. More... | |
EDescent & | operator++ (EDescent &type) |
EDescent | operator++ (EDescent &type, int) |
EDescent & | operator-- (EDescent &type) |
EDescent | operator-- (EDescent &type, int) |
EDescent | StringToEDescent (std::string s) |
std::string | ESecantToString (ESecant tr) |
int | isValidSecant (ESecant s) |
Verifies validity of a Secant enum. More... | |
ESecant & | operator++ (ESecant &type) |
ESecant | operator++ (ESecant &type, int) |
ESecant & | operator-- (ESecant &type) |
ESecant | operator-- (ESecant &type, int) |
ESecant | StringToESecant (std::string s) |
std::string | EKrylovToString (EKrylov tr) |
int | isValidKrylov (EKrylov d) |
Verifies validity of a Secant enum. More... | |
EKrylov & | operator++ (EKrylov &type) |
EKrylov | operator++ (EKrylov &type, int) |
EKrylov & | operator-- (EKrylov &type) |
EKrylov | operator-- (EKrylov &type, int) |
EKrylov | StringToEKrylov (std::string s) |
std::string | ENonlinearCGToString (ENonlinearCG tr) |
int | isValidNonlinearCG (ENonlinearCG s) |
Verifies validity of a NonlinearCG enum. More... | |
ENonlinearCG & | operator++ (ENonlinearCG &type) |
ENonlinearCG | operator++ (ENonlinearCG &type, int) |
ENonlinearCG & | operator-- (ENonlinearCG &type) |
ENonlinearCG | operator-- (ENonlinearCG &type, int) |
ENonlinearCG | StringToENonlinearCG (std::string s) |
std::string | ELineSearchToString (ELineSearch ls) |
int | isValidLineSearch (ELineSearch ls) |
Verifies validity of a LineSearch enum. More... | |
ELineSearch & | operator++ (ELineSearch &type) |
ELineSearch | operator++ (ELineSearch &type, int) |
ELineSearch & | operator-- (ELineSearch &type) |
ELineSearch | operator-- (ELineSearch &type, int) |
ELineSearch | StringToELineSearch (std::string s) |
std::string | ECurvatureConditionToString (ECurvatureCondition ls) |
int | isValidCurvatureCondition (ECurvatureCondition ls) |
Verifies validity of a CurvatureCondition enum. More... | |
ECurvatureCondition & | operator++ (ECurvatureCondition &type) |
ECurvatureCondition | operator++ (ECurvatureCondition &type, int) |
ECurvatureCondition & | operator-- (ECurvatureCondition &type) |
ECurvatureCondition | operator-- (ECurvatureCondition &type, int) |
ECurvatureCondition | StringToECurvatureCondition (std::string s) |
std::string | ECGFlagToString (ECGFlag cgf) |
std::string | ETestObjectivesToString (ETestObjectives to) |
int | isValidTestObjectives (ETestObjectives to) |
Verifies validity of a TestObjectives enum. More... | |
ETestObjectives & | operator++ (ETestObjectives &type) |
ETestObjectives | operator++ (ETestObjectives &type, int) |
ETestObjectives & | operator-- (ETestObjectives &type) |
ETestObjectives | operator-- (ETestObjectives &type, int) |
ETestObjectives | StringToETestObjectives (std::string s) |
std::string | ETestOptProblemToString (ETestOptProblem to) |
int | isValidTestOptProblem (ETestOptProblem to) |
Verifies validity of a TestOptProblem enum. More... | |
ETestOptProblem & | operator++ (ETestOptProblem &type) |
ETestOptProblem | operator++ (ETestOptProblem &type, int) |
ETestOptProblem & | operator-- (ETestOptProblem &type) |
ETestOptProblem | operator-- (ETestOptProblem &type, int) |
ETestOptProblem | StringToETestOptProblem (std::string s) |
std::string | EConstraintToString (EConstraint c) |
int | isValidConstraint (EConstraint c) |
Verifies validity of a Secant enum. More... | |
EConstraint & | operator++ (EConstraint &type) |
EConstraint | operator++ (EConstraint &type, int) |
EConstraint & | operator-- (EConstraint &type) |
EConstraint | operator-- (EConstraint &type, int) |
EConstraint | StringToEConstraint (std::string s) |
template<class Element , class Real > | |
Real | rol_cast (const Element &val) |
void | addJSONBlockToPL (const Json::Value &block, Teuchos::ParameterList &parlist) |
Iterate over a block and insert key-value pairs into the Teuchos::ParameterList. More... | |
void | addJSONPairToPL (const Json::Value &block, const std::string &key, Teuchos::ParameterList &parlist) |
Given a JSON block and a key, get the value and insert the key-value pair into a Teuchos::ParameterList. If the value is itself a block, recursively iterate. More... | |
void | JSON_Parameters (const std::string &jsonFileName, Teuchos::ParameterList &parlist) |
Read a JSON file and store all parameters in a Teuchos::ParameterList. Checks for a key called "Algorithm" which has a string value which can specify a Step Type (Linesearch or Trust-Region) and either a Descent Type or a Trust-Region Subproblem Solver Type. More... | |
template<class Real > | |
void | stepFactory (Teuchos::ParameterList &parlist, Teuchos::RCP< ROL::Step< Real > > &step) |
A minimalist step factory which specializes the Step Type depending on whether a Trust-Region or Linesearch has been selected. More... | |
enum ROL::ETrustRegion |
Enumeration of trust-region solver types.
Enumerator | |
---|---|
TRUSTREGION_CAUCHYPOINT | |
TRUSTREGION_TRUNCATEDCG | |
TRUSTREGION_DOGLEG | |
TRUSTREGION_DOUBLEDOGLEG | |
TRUSTREGION_LAST |
Definition at line 62 of file ROL_TrustRegionTypes.hpp.
Enumeration of trust-region model types.
Enumerator | |
---|---|
TRUSTREGION_MODEL_COLEMANLI | |
TRUSTREGION_MODEL_KELLEYSACHS | |
TRUSTREGION_MODEL_LAST |
Definition at line 132 of file ROL_TrustRegionTypes.hpp.
Enumation of flags used by trust-region solvers.
Enumerator | |
---|---|
TRUSTREGION_FLAG_SUCCESS | |
TRUSTREGION_FLAG_POSPREDNEG | |
TRUSTREGION_FLAG_NPOSPREDPOS | |
TRUSTREGION_FLAG_NPOSPREDNEG | |
TRUSTREGION_FLAG_QMINSUFDEC | |
TRUSTREGION_FLAG_NAN | |
TRUSTREGION_FLAG_UNDEFINED |
Definition at line 201 of file ROL_TrustRegionTypes.hpp.
enum ROL::EDistribution |
Definition at line 69 of file ROL_DistributionFactory.hpp.
enum ROL::ERiskMeasure |
Definition at line 81 of file ROL_RiskMeasureFactory.hpp.
enum ROL::EAbsoluteValue |
Enumerator | |
---|---|
ABSOLUTEVALUE_TRUE | |
ABSOLUTEVALUE_SQUAREROOT | |
ABSOLUTEVALUE_SQRTDENOM | |
ABSOLUTEVALUE_C2 | |
ABSOLUTEVALUE_LAST |
Definition at line 52 of file ROL_AbsoluteValue.hpp.
enum ROL::EStep |
Enumeration of step types.
Enumerator | |
---|---|
STEP_AUGMENTEDLAGRANGIAN | |
STEP_BUNDLE | |
STEP_COMPOSITESTEP | |
STEP_LINESEARCH | |
STEP_MOREAUYOSIDAPENALTY | |
STEP_PRIMALDUALACTIVESET | |
STEP_TRUSTREGION | |
STEP_INTERIORPOINT | |
STEP_LAST |
Definition at line 192 of file ROL_Types.hpp.
enum ROL::EBoundAlgorithm |
Enumeration of algorithms to handle bound constraints.
Enumerator | |
---|---|
BOUNDALGORITHM_PROJECTED | |
BOUNDALGORITHM_PRIMALDUALACTIVESET | |
BOUNDALGORITHM_INTERIORPOINTS | |
BOUNDALGORITHM_LAST |
Definition at line 274 of file ROL_Types.hpp.
enum ROL::EDescent |
Enumeration of descent direction types.
Enumerator | |
---|---|
DESCENT_STEEPEST | |
DESCENT_NONLINEARCG | |
DESCENT_SECANT | |
DESCENT_NEWTON | |
DESCENT_NEWTONKRYLOV | |
DESCENT_LAST |
Definition at line 345 of file ROL_Types.hpp.
enum ROL::ESecant |
Enumeration of secant update algorithms.
Enumerator | |
---|---|
SECANT_LBFGS | |
SECANT_LDFP | |
SECANT_LSR1 | |
SECANT_BARZILAIBORWEIN | |
SECANT_USERDEFINED | |
SECANT_LAST |
Definition at line 420 of file ROL_Types.hpp.
enum ROL::EKrylov |
Enumeration of Krylov methods.
Enumerator | |
---|---|
KRYLOV_CG | |
KRYLOV_CR | |
KRYLOV_GMRES | |
KRYLOV_USERDEFINED | |
KRYLOV_LAST |
Definition at line 493 of file ROL_Types.hpp.
enum ROL::ENonlinearCG |
Enumeration of nonlinear CG algorithms.
Definition at line 569 of file ROL_Types.hpp.
enum ROL::ELineSearch |
Enumeration of line-search types.
Definition at line 661 of file ROL_Types.hpp.
Enumeration of line-search curvature conditions.
Definition at line 744 of file ROL_Types.hpp.
enum ROL::ECGFlag |
Enumation of flags used by conjugate gradient methods.
Enumerator | |
---|---|
CG_FLAG_SUCCESS | |
CG_FLAG_ITEREXCEED | |
CG_FLAG_NEGCURVE | |
CG_FLAG_TRRADEX | |
CG_FLAG_UNDEFINED |
Definition at line 823 of file ROL_Types.hpp.
enum ROL::ETestObjectives |
Enumeration of test objective functions.
Definition at line 863 of file ROL_Types.hpp.
enum ROL::ETestOptProblem |
Enumeration of test optimization problems.
Definition at line 952 of file ROL_Types.hpp.
enum ROL::EConstraint |
Enumeration of constraint types.
Enumerator | |
---|---|
CONSTRAINT_EQUALITY | |
CONSTRAINT_INEQUALITY | |
CONSTRAINT_LAST |
Definition at line 1037 of file ROL_Types.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< Vector< Real > > & | a | ) |
Definition at line 268 of file ROL_PartitionedVector.hpp.
Referenced by main(), ROL::Refactor::OptimizationProblem< Real >::OptimizationProblem(), and ROL::OptimizationProblem< Real >::OptimizationProblem().
Teuchos::RCP<const Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a | ) |
Definition at line 279 of file ROL_PartitionedVector.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< Vector< Real > > & | a, |
const Teuchos::RCP< Vector< Real > > & | b | ||
) |
Definition at line 290 of file ROL_PartitionedVector.hpp.
Teuchos::RCP<const Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a, |
const Teuchos::RCP< const Vector< Real > > & | b | ||
) |
Definition at line 302 of file ROL_PartitionedVector.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< Vector< Real > > & | a, |
const Teuchos::RCP< Vector< Real > > & | b, | ||
const Teuchos::RCP< Vector< Real > > & | c | ||
) |
Definition at line 314 of file ROL_PartitionedVector.hpp.
Teuchos::RCP<const Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a, |
const Teuchos::RCP< const Vector< Real > > & | b, | ||
const Teuchos::RCP< const Vector< Real > > & | c | ||
) |
Definition at line 327 of file ROL_PartitionedVector.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< Vector< Real > > & | a, |
const Teuchos::RCP< Vector< Real > > & | b, | ||
const Teuchos::RCP< Vector< Real > > & | c, | ||
const Teuchos::RCP< Vector< Real > > & | d | ||
) |
Definition at line 340 of file ROL_PartitionedVector.hpp.
Teuchos::RCP<const Vector<Real> > ROL::CreatePartitionedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a, |
const Teuchos::RCP< const Vector< Real > > & | b, | ||
const Teuchos::RCP< const Vector< Real > > & | c, | ||
const Teuchos::RCP< const Vector< Real > > & | d | ||
) |
Definition at line 354 of file ROL_PartitionedVector.hpp.
Teuchos::RCP<BoundConstraint<Real> > ROL::CreateBoundConstraint_Partitioned | ( | const Teuchos::RCP< BoundConstraint< Real > > & | bnd1, |
const Teuchos::RCP< BoundConstraint< Real > > & | bnd2 | ||
) |
Definition at line 403 of file ROL_BoundConstraint_Partitioned.hpp.
Referenced by ROL::Refactor::OptimizationProblem< Real >::OptimizationProblem().
Teuchos::RCP<EqualityConstraint<Real> > ROL::CreateEqualityConstraintPartitioned | ( | const Teuchos::RCP< EqualityConstraint< Real > > & | con1, |
const Teuchos::RCP< EqualityConstraint< Real > > & | con2 | ||
) |
Definition at line 117 of file ROL_EqualityConstraint_Partitioned.hpp.
Referenced by main().
Teuchos::RCP<EqualityConstraint<Real> > ROL::CreateEqualityConstraintPartitioned | ( | const Teuchos::RCP< EqualityConstraint< Real > > & | con1, |
const Teuchos::RCP< EqualityConstraint< Real > > & | con2, | ||
const Teuchos::RCP< EqualityConstraint< Real > > & | con3 | ||
) |
Definition at line 130 of file ROL_EqualityConstraint_Partitioned.hpp.
Real ROL::normL1 | ( | const Vector< Real > & | x | ) |
Definition at line 52 of file ROL_VectorNorms.hpp.
References ROL::Vector< Real >::clone().
Real ROL::normLp | ( | const Vector< Real > & | x, |
Exponent | p | ||
) |
Definition at line 62 of file ROL_VectorNorms.hpp.
References ROL::Vector< Real >::clone().
Real ROL::normLinf | ( | const Vector< Real > & | x | ) |
Definition at line 73 of file ROL_VectorNorms.hpp.
References ROL::Vector< Real >::clone().
|
inline |
Definition at line 63 of file ROL_KrylovFactory.hpp.
References KRYLOV_CG, KRYLOV_CR, KRYLOV_GMRES, and StringToEKrylov().
|
inline |
Definition at line 64 of file ROL_LineSearchFactory.hpp.
References LINESEARCH_BACKTRACKING, LINESEARCH_BISECTION, LINESEARCH_BRENTS, LINESEARCH_CUBICINTERP, LINESEARCH_GOLDENSECTION, LINESEARCH_ITERATIONSCALING, LINESEARCH_PATHBASEDTARGETLEVEL, and StringToELineSearch().
|
inline |
Definition at line 60 of file ROL_SecantFactory.hpp.
References SECANT_BARZILAIBORWEIN, SECANT_LBFGS, SECANT_LDFP, and SECANT_LSR1.
|
inline |
Definition at line 71 of file ROL_SecantFactory.hpp.
References SECANT_BARZILAIBORWEIN, SECANT_LBFGS, SECANT_LDFP, SECANT_LSR1, and StringToESecant().
|
inline |
Definition at line 60 of file ROL_TrustRegionFactory.hpp.
References StringToETrustRegion(), TRUSTREGION_CAUCHYPOINT, TRUSTREGION_DOGLEG, TRUSTREGION_DOUBLEDOGLEG, and TRUSTREGION_TRUNCATEDCG.
|
inline |
Definition at line 70 of file ROL_TrustRegionTypes.hpp.
References TRUSTREGION_CAUCHYPOINT, TRUSTREGION_DOGLEG, TRUSTREGION_DOUBLEDOGLEG, TRUSTREGION_LAST, and TRUSTREGION_TRUNCATEDCG.
Referenced by main(), ROL::TrustRegionStep< Real >::printName(), and StringToETrustRegion().
|
inline |
Verifies validity of a TrustRegion enum.
tr | [in] - enum of the TrustRegion |
Definition at line 88 of file ROL_TrustRegionTypes.hpp.
References TRUSTREGION_CAUCHYPOINT, TRUSTREGION_DOGLEG, TRUSTREGION_DOUBLEDOGLEG, and TRUSTREGION_TRUNCATEDCG.
|
inline |
Definition at line 96 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 100 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 106 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 110 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 116 of file ROL_TrustRegionTypes.hpp.
References ETrustRegionToString(), removeStringFormat(), TRUSTREGION_CAUCHYPOINT, and TRUSTREGION_LAST.
Referenced by ROL::TrustRegionStep< Real >::parseParameterList(), and TrustRegionFactory().
|
inline |
Definition at line 138 of file ROL_TrustRegionTypes.hpp.
References TRUSTREGION_MODEL_COLEMANLI, TRUSTREGION_MODEL_KELLEYSACHS, and TRUSTREGION_MODEL_LAST.
Referenced by ROL::TrustRegionStep< Real >::printName(), and StringToETrustRegionModel().
|
inline |
Verifies validity of a TrustRegionModel enum.
tr | [in] - enum of the TrustRegionModel |
Definition at line 154 of file ROL_TrustRegionTypes.hpp.
References TRUSTREGION_MODEL_COLEMANLI, and TRUSTREGION_MODEL_KELLEYSACHS.
|
inline |
Definition at line 160 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 164 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 170 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 174 of file ROL_TrustRegionTypes.hpp.
|
inline |
Definition at line 180 of file ROL_TrustRegionTypes.hpp.
References ETrustRegionModelToString(), removeStringFormat(), TRUSTREGION_MODEL_COLEMANLI, and TRUSTREGION_MODEL_LAST.
Referenced by ROL::TrustRegionStep< Real >::parseParameterList(), and ROL::TrustRegion< Real >::TrustRegion().
|
inline |
Definition at line 212 of file ROL_TrustRegionTypes.hpp.
References TRUSTREGION_FLAG_NAN, TRUSTREGION_FLAG_NPOSPREDNEG, TRUSTREGION_FLAG_NPOSPREDPOS, TRUSTREGION_FLAG_POSPREDNEG, TRUSTREGION_FLAG_QMINSUFDEC, and TRUSTREGION_FLAG_SUCCESS.
Referenced by ROL::TrustRegionStep< Real >::printHeader().
|
inline |
Definition at line 90 of file ROL_DistributionFactory.hpp.
References DISTRIBUTION_ARCSINE, DISTRIBUTION_BETA, DISTRIBUTION_CAUCHY, DISTRIBUTION_DIRAC, DISTRIBUTION_EXPONENTIAL, DISTRIBUTION_GAMMA, DISTRIBUTION_GAUSSIAN, DISTRIBUTION_KUMARASWAMY, DISTRIBUTION_LAPLACE, DISTRIBUTION_LAST, DISTRIBUTION_LOGISTIC, DISTRIBUTION_PARABOLIC, DISTRIBUTION_RAISEDCOSINE, DISTRIBUTION_SMALE, DISTRIBUTION_TRIANGLE, DISTRIBUTION_TRUNCATEDEXPONENTIAL, DISTRIBUTION_TRUNCATEDGAUSSIAN, and DISTRIBUTION_UNIFORM.
Referenced by StringToEDistribution().
|
inline |
Definition at line 116 of file ROL_DistributionFactory.hpp.
References DISTRIBUTION_ARCSINE, DISTRIBUTION_BETA, DISTRIBUTION_CAUCHY, DISTRIBUTION_DIRAC, DISTRIBUTION_EXPONENTIAL, DISTRIBUTION_GAMMA, DISTRIBUTION_GAUSSIAN, DISTRIBUTION_KUMARASWAMY, DISTRIBUTION_LAPLACE, DISTRIBUTION_LOGISTIC, DISTRIBUTION_PARABOLIC, DISTRIBUTION_RAISEDCOSINE, DISTRIBUTION_SMALE, DISTRIBUTION_TRIANGLE, DISTRIBUTION_TRUNCATEDEXPONENTIAL, DISTRIBUTION_TRUNCATEDGAUSSIAN, and DISTRIBUTION_UNIFORM.
|
inline |
Definition at line 136 of file ROL_DistributionFactory.hpp.
|
inline |
Definition at line 140 of file ROL_DistributionFactory.hpp.
|
inline |
Definition at line 146 of file ROL_DistributionFactory.hpp.
|
inline |
Definition at line 150 of file ROL_DistributionFactory.hpp.
|
inline |
Definition at line 156 of file ROL_DistributionFactory.hpp.
References DISTRIBUTION_ARCSINE, DISTRIBUTION_LAST, DISTRIBUTION_UNIFORM, EDistributionToString(), and removeStringFormat().
Referenced by DistributionFactory().
|
inline |
Definition at line 167 of file ROL_DistributionFactory.hpp.
References DISTRIBUTION_ARCSINE, DISTRIBUTION_BETA, DISTRIBUTION_CAUCHY, DISTRIBUTION_DIRAC, DISTRIBUTION_EXPONENTIAL, DISTRIBUTION_GAMMA, DISTRIBUTION_GAUSSIAN, DISTRIBUTION_KUMARASWAMY, DISTRIBUTION_LAPLACE, DISTRIBUTION_LOGISTIC, DISTRIBUTION_PARABOLIC, DISTRIBUTION_RAISEDCOSINE, DISTRIBUTION_SMALE, DISTRIBUTION_TRIANGLE, DISTRIBUTION_TRUNCATEDEXPONENTIAL, DISTRIBUTION_TRUNCATEDGAUSSIAN, DISTRIBUTION_UNIFORM, and StringToEDistribution().
|
inline |
Definition at line 107 of file ROL_RiskMeasureFactory.hpp.
References RISKMEASURE_CHEBYSHEVKUSUOKA, RISKMEASURE_CHI2DIVERGENCE, RISKMEASURE_COHERENTEXPUTILITY, RISKMEASURE_CVAR, RISKMEASURE_EXPUTILITY, RISKMEASURE_HMCR, RISKMEASURE_KLDIVERGENCE, RISKMEASURE_LAST, RISKMEASURE_LOGEXPONENTIALQUADRANGLE, RISKMEASURE_LOGQUANTILEQUADRANGLE, RISKMEASURE_MEANDEVIATION, RISKMEASURE_MEANDEVIATIONFROMTARGET, RISKMEASURE_MEANVARIANCE, RISKMEASURE_MEANVARIANCEFROMTARGET, RISKMEASURE_MEANVARIANCEQUADRANGLE, RISKMEASURE_MIXEDQUANTILEQUADRANGLE, RISKMEASURE_MOREAUYOSIDACVAR, RISKMEASURE_QUANTILEQUADRANGLE, RISKMEASURE_QUANTILERADIUSQUADRANGLE, RISKMEASURE_SMOOTHEDWORSTCASEQUADRANGLE, RISKMEASURE_SPECTRALRISK, RISKMEASURE_SUPERQUANTILEQUADRANGLE, and RISKMEASURE_TRUNCATEDMEANQUADRANGLE.
Referenced by StringToERiskMeasure().
|
inline |
Definition at line 162 of file ROL_RiskMeasureFactory.hpp.
References RISKMEASURE_CHEBYSHEVKUSUOKA, RISKMEASURE_CHI2DIVERGENCE, RISKMEASURE_COHERENTEXPUTILITY, RISKMEASURE_CVAR, RISKMEASURE_EXPUTILITY, RISKMEASURE_HMCR, RISKMEASURE_KLDIVERGENCE, RISKMEASURE_LOGEXPONENTIALQUADRANGLE, RISKMEASURE_LOGQUANTILEQUADRANGLE, RISKMEASURE_MEANDEVIATION, RISKMEASURE_MEANDEVIATIONFROMTARGET, RISKMEASURE_MEANVARIANCE, RISKMEASURE_MEANVARIANCEFROMTARGET, RISKMEASURE_MEANVARIANCEQUADRANGLE, RISKMEASURE_MIXEDQUANTILEQUADRANGLE, RISKMEASURE_MOREAUYOSIDACVAR, RISKMEASURE_QUANTILEQUADRANGLE, RISKMEASURE_QUANTILERADIUSQUADRANGLE, RISKMEASURE_SMOOTHEDWORSTCASEQUADRANGLE, RISKMEASURE_SPECTRALRISK, RISKMEASURE_SUPERQUANTILEQUADRANGLE, and RISKMEASURE_TRUNCATEDMEANQUADRANGLE.
|
inline |
Definition at line 187 of file ROL_RiskMeasureFactory.hpp.
|
inline |
Definition at line 191 of file ROL_RiskMeasureFactory.hpp.
|
inline |
Definition at line 197 of file ROL_RiskMeasureFactory.hpp.
|
inline |
Definition at line 201 of file ROL_RiskMeasureFactory.hpp.
|
inline |
Definition at line 207 of file ROL_RiskMeasureFactory.hpp.
References ERiskMeasureToString(), removeStringFormat(), RISKMEASURE_CVAR, and RISKMEASURE_LAST.
Referenced by RiskMeasureFactory().
|
inline |
Definition at line 218 of file ROL_RiskMeasureFactory.hpp.
References RISKMEASURE_CHEBYSHEVKUSUOKA, RISKMEASURE_CHI2DIVERGENCE, RISKMEASURE_COHERENTEXPUTILITY, RISKMEASURE_CVAR, RISKMEASURE_EXPUTILITY, RISKMEASURE_HMCR, RISKMEASURE_KLDIVERGENCE, RISKMEASURE_LOGEXPONENTIALQUADRANGLE, RISKMEASURE_LOGQUANTILEQUADRANGLE, RISKMEASURE_MEANDEVIATION, RISKMEASURE_MEANDEVIATIONFROMTARGET, RISKMEASURE_MEANVARIANCE, RISKMEASURE_MEANVARIANCEFROMTARGET, RISKMEASURE_MEANVARIANCEQUADRANGLE, RISKMEASURE_MIXEDQUANTILEQUADRANGLE, RISKMEASURE_MOREAUYOSIDACVAR, RISKMEASURE_QUANTILEQUADRANGLE, RISKMEASURE_QUANTILERADIUSQUADRANGLE, RISKMEASURE_SMOOTHEDWORSTCASEQUADRANGLE, RISKMEASURE_SPECTRALRISK, RISKMEASURE_SUPERQUANTILEQUADRANGLE, RISKMEASURE_TRUNCATEDMEANQUADRANGLE, and StringToERiskMeasure().
|
inline |
Definition at line 53 of file ROL_RiskMeasureInfo.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< Vector< Real > > & | a, |
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 284 of file ROL_SimulatedVector.hpp.
Teuchos::RCP<const Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a, |
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 295 of file ROL_SimulatedVector.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< Vector< Real > > & | a, |
const Teuchos::RCP< Vector< Real > > & | b, | ||
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 306 of file ROL_SimulatedVector.hpp.
Teuchos::RCP<const Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a, |
const Teuchos::RCP< const Vector< Real > > & | b, | ||
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 319 of file ROL_SimulatedVector.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< Vector< Real > > & | a, |
const Teuchos::RCP< Vector< Real > > & | b, | ||
const Teuchos::RCP< Vector< Real > > & | c, | ||
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 332 of file ROL_SimulatedVector.hpp.
Teuchos::RCP<const Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a, |
const Teuchos::RCP< const Vector< Real > > & | b, | ||
const Teuchos::RCP< const Vector< Real > > & | c, | ||
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 346 of file ROL_SimulatedVector.hpp.
Teuchos::RCP<Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< Vector< Real > > & | a, |
const Teuchos::RCP< Vector< Real > > & | b, | ||
const Teuchos::RCP< Vector< Real > > & | c, | ||
const Teuchos::RCP< Vector< Real > > & | d, | ||
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 360 of file ROL_SimulatedVector.hpp.
Teuchos::RCP<const Vector<Real> > ROL::CreateSimulatedVector | ( | const Teuchos::RCP< const Vector< Real > > & | a, |
const Teuchos::RCP< const Vector< Real > > & | b, | ||
const Teuchos::RCP< const Vector< Real > > & | c, | ||
const Teuchos::RCP< const Vector< Real > > & | d, | ||
const Teuchos::RCP< BatchManager< Real > > & | bman | ||
) |
Definition at line 375 of file ROL_SimulatedVector.hpp.
Teuchos::SerialDenseMatrix<int, Real> ROL::computeDenseHessian | ( | Objective< Real > & | obj, |
const Vector< Real > & | x | ||
) |
Definition at line 63 of file ROL_HelperFunctions.hpp.
References ROL::Vector< Real >::basis(), ROL::Vector< Real >::clone(), ROL::Vector< Real >::dimension(), and ROL::Objective< Real >::hessVec().
Referenced by main().
Teuchos::SerialDenseMatrix<int, Real> ROL::computeDotMatrix | ( | const Vector< Real > & | x | ) |
Definition at line 88 of file ROL_HelperFunctions.hpp.
References ROL::Vector< Real >::basis(), ROL::Vector< Real >::clone(), and ROL::Vector< Real >::dimension().
Referenced by main().
std::vector<std::vector<Real> > ROL::computeEigenvalues | ( | const Teuchos::SerialDenseMatrix< int, Real > & | mat | ) |
Definition at line 109 of file ROL_HelperFunctions.hpp.
Referenced by main().
std::vector<std::vector<Real> > ROL::computeGenEigenvalues | ( | const Teuchos::SerialDenseMatrix< int, Real > & | A, |
const Teuchos::SerialDenseMatrix< int, Real > & | B | ||
) |
Definition at line 147 of file ROL_HelperFunctions.hpp.
Teuchos::SerialDenseMatrix<int, Real> ROL::computeInverse | ( | const Teuchos::SerialDenseMatrix< int, Real > & | mat | ) |
Definition at line 194 of file ROL_HelperFunctions.hpp.
void ROL::setParameter | ( | Teuchos::ParameterList & | parlist, |
const std::vector< std::string > & | location, | ||
const std::vector< std::string >::iterator | iter, | ||
ParameterType | value | ||
) |
Definition at line 112 of file ROL_ParameterListConverters.hpp.
Referenced by tierParameterList().
|
inline |
Produce a heirarchical parameter list using the new names from a flat list of the old names.
Definition at line 131 of file ROL_ParameterListConverters.hpp.
References ROL::StringList::join(), removeStringFormat(), and setParameter().
void ROL::getTestObjectives | ( | Teuchos::RCP< Objective< Real > > & | obj, |
Teuchos::RCP< Vector< Real > > & | x0, | ||
Teuchos::RCP< Vector< Real > > & | x, | ||
const ETestObjectives | test | ||
) |
Definition at line 81 of file ROL_TestObjectives.hpp.
References ROL::ZOO::getBeale(), ROL::ZOO::getFreudensteinRoth(), ROL::ZOO::getLeastSquares(), ROL::ZOO::getPoissonControl(), ROL::ZOO::getPoissonInversion(), ROL::ZOO::getPowell(), ROL::ZOO::getSumOfSquares(), ROL::ZOO::getZakharov(), TESTOBJECTIVES_BEALE, TESTOBJECTIVES_FREUDENSTEINANDROTH, TESTOBJECTIVES_LAST, TESTOBJECTIVES_LEASTSQUARES, TESTOBJECTIVES_POISSONCONTROL, TESTOBJECTIVES_POISSONINVERSION, TESTOBJECTIVES_POWELL, TESTOBJECTIVES_ROSENBROCK, TESTOBJECTIVES_SUMOFSQUARES, and TESTOBJECTIVES_ZAKHAROV.
void ROL::getTestObjectives | ( | Teuchos::RCP< Objective< Real > > & | obj, |
Teuchos::RCP< BoundConstraint< Real > > & | con, | ||
Teuchos::RCP< Vector< Real > > & | x0, | ||
Teuchos::RCP< Vector< Real > > & | x, | ||
const ETestOptProblem | test | ||
) |
Definition at line 102 of file ROL_TestObjectives.hpp.
References ROL::ZOO::getBVP(), ROL::ZOO::getHS1(), ROL::ZOO::getHS2(), ROL::ZOO::getHS25(), ROL::ZOO::getHS3(), ROL::ZOO::getHS38(), ROL::ZOO::getHS4(), ROL::ZOO::getHS45(), ROL::ZOO::getHS5(), TESTOPTPROBLEM_BVP, TESTOPTPROBLEM_HS1, TESTOPTPROBLEM_HS2, TESTOPTPROBLEM_HS25, TESTOPTPROBLEM_HS3, TESTOPTPROBLEM_HS38, TESTOPTPROBLEM_HS4, TESTOPTPROBLEM_HS45, TESTOPTPROBLEM_HS5, and TESTOPTPROBLEM_LAST.
std::string ROL::NumberToString | ( | T | Number | ) |
Definition at line 80 of file ROL_Types.hpp.
Referenced by ROL::TrustRegionStep< Real >::printHeader().
|
inline |
Platform-dependent machine epsilon.
Definition at line 139 of file ROL_Types.hpp.
|
inline |
Tolerance for various equality tests.
Definition at line 145 of file ROL_Types.hpp.
|
inline |
Platform-dependent maximum double.
Definition at line 151 of file ROL_Types.hpp.
|
inline |
Definition at line 155 of file ROL_Types.hpp.
|
inline |
Definition at line 159 of file ROL_Types.hpp.
|
inline |
Platform-dependent minimum double.
Definition at line 165 of file ROL_Types.hpp.
|
inline |
Definition at line 174 of file ROL_Types.hpp.
Referenced by ROL::ObjectiveFromBoundConstraint< Real >::StringToEBarrierType(), StringToEBoundAlgorithm(), StringToEConstraint(), StringToECurvatureCondition(), StringToEDescent(), StringToEDistribution(), StringToEKrylov(), StringToELineSearch(), StringToENonlinearCG(), StringToERiskMeasure(), StringToESecant(), StringToEStep(), StringToETestObjectives(), StringToETestOptProblem(), StringToETrustRegion(), StringToETrustRegionModel(), and tierParameterList().
|
inline |
Definition at line 204 of file ROL_Types.hpp.
References STEP_AUGMENTEDLAGRANGIAN, STEP_BUNDLE, STEP_COMPOSITESTEP, STEP_INTERIORPOINT, STEP_LAST, STEP_LINESEARCH, STEP_MOREAUYOSIDAPENALTY, STEP_PRIMALDUALACTIVESET, and STEP_TRUSTREGION.
Referenced by StringToEStep().
|
inline |
Verifies validity of a TrustRegion enum.
tr | [in] - enum of the TrustRegion |
Definition at line 226 of file ROL_Types.hpp.
References STEP_AUGMENTEDLAGRANGIAN, STEP_BUNDLE, STEP_COMPOSITESTEP, STEP_INTERIORPOINT, STEP_LINESEARCH, STEP_MOREAUYOSIDAPENALTY, STEP_PRIMALDUALACTIVESET, and STEP_TRUSTREGION.
Referenced by ROL::Algorithm< Real >::Algorithm().
Definition at line 237 of file ROL_Types.hpp.
Definition at line 241 of file ROL_Types.hpp.
Definition at line 247 of file ROL_Types.hpp.
Definition at line 251 of file ROL_Types.hpp.
|
inline |
Definition at line 257 of file ROL_Types.hpp.
References EStepToString(), removeStringFormat(), STEP_AUGMENTEDLAGRANGIAN, STEP_LAST, and STEP_TRUSTREGION.
Referenced by ROL::Algorithm< Real >::Algorithm(), ROL::StatusTestFactory< Real >::getStatusTest(), and ROL::StepFactory< Real >::getStep().
|
inline |
Definition at line 281 of file ROL_Types.hpp.
References BOUNDALGORITHM_INTERIORPOINTS, BOUNDALGORITHM_LAST, BOUNDALGORITHM_PRIMALDUALACTIVESET, and BOUNDALGORITHM_PROJECTED.
Referenced by StringToEBoundAlgorithm().
|
inline |
Verifies validity of a Bound Algorithm enum.
tr | [in] - enum of the Bound Algorithm |
Definition at line 298 of file ROL_Types.hpp.
References BOUNDALGORITHM_INTERIORPOINTS, BOUNDALGORITHM_PRIMALDUALACTIVESET, and BOUNDALGORITHM_PROJECTED.
|
inline |
Definition at line 305 of file ROL_Types.hpp.
|
inline |
Definition at line 309 of file ROL_Types.hpp.
|
inline |
Definition at line 315 of file ROL_Types.hpp.
|
inline |
Definition at line 319 of file ROL_Types.hpp.
|
inline |
Definition at line 325 of file ROL_Types.hpp.
References BOUNDALGORITHM_LAST, BOUNDALGORITHM_PROJECTED, EBoundAlgorithmToString(), and removeStringFormat().
|
inline |
Definition at line 354 of file ROL_Types.hpp.
References DESCENT_LAST, DESCENT_NEWTON, DESCENT_NEWTONKRYLOV, DESCENT_NONLINEARCG, DESCENT_SECANT, and DESCENT_STEEPEST.
Referenced by main(), ROL::NewtonStep< Real >::printHeader(), ROL::GradientStep< Real >::printHeader(), ROL::NonlinearCGStep< Real >::printHeader(), ROL::SecantStep< Real >::printHeader(), ROL::ProjectedNewtonStep< Real >::printHeader(), ROL::ProjectedSecantStep< Real >::printHeader(), ROL::NewtonKrylovStep< Real >::printHeader(), ROL::ProjectedNewtonKrylovStep< Real >::printHeader(), ROL::NewtonStep< Real >::printName(), ROL::GradientStep< Real >::printName(), ROL::NonlinearCGStep< Real >::printName(), ROL::SecantStep< Real >::printName(), ROL::ProjectedNewtonStep< Real >::printName(), ROL::ProjectedSecantStep< Real >::printName(), ROL::NewtonKrylovStep< Real >::printName(), ROL::ProjectedNewtonKrylovStep< Real >::printName(), and StringToEDescent().
|
inline |
Verifies validity of a Secant enum.
tr | [in] - enum of the Secant |
Definition at line 373 of file ROL_Types.hpp.
References DESCENT_NEWTON, DESCENT_NEWTONKRYLOV, DESCENT_NONLINEARCG, DESCENT_SECANT, and DESCENT_STEEPEST.
Definition at line 382 of file ROL_Types.hpp.
Definition at line 386 of file ROL_Types.hpp.
Definition at line 392 of file ROL_Types.hpp.
Definition at line 396 of file ROL_Types.hpp.
|
inline |
Definition at line 402 of file ROL_Types.hpp.
References DESCENT_LAST, DESCENT_SECANT, DESCENT_STEEPEST, EDescentToString(), and removeStringFormat().
Referenced by ROL::LineSearchStep< Real >::initialize(), ROL::LineSearch< Real >::LineSearch(), and ROL::ScalarMinimizationLineSearch< Real >::ScalarMinimizationLineSearch().
|
inline |
Definition at line 429 of file ROL_Types.hpp.
References SECANT_BARZILAIBORWEIN, SECANT_LAST, SECANT_LBFGS, SECANT_LDFP, SECANT_LSR1, and SECANT_USERDEFINED.
Referenced by ROL::SecantStep< Real >::printName(), ROL::ProjectedSecantStep< Real >::printName(), ROL::NewtonKrylovStep< Real >::printName(), ROL::ProjectedNewtonKrylovStep< Real >::printName(), ROL::TrustRegionStep< Real >::printName(), and StringToESecant().
|
inline |
Verifies validity of a Secant enum.
tr | [in] - enum of the Secant |
Definition at line 448 of file ROL_Types.hpp.
References SECANT_BARZILAIBORWEIN, SECANT_LBFGS, SECANT_LDFP, SECANT_LSR1, and SECANT_USERDEFINED.
Definition at line 457 of file ROL_Types.hpp.
Definition at line 461 of file ROL_Types.hpp.
Definition at line 467 of file ROL_Types.hpp.
Definition at line 471 of file ROL_Types.hpp.
|
inline |
Definition at line 477 of file ROL_Types.hpp.
References ESecantToString(), removeStringFormat(), SECANT_LAST, and SECANT_LBFGS.
Referenced by ROL::NewtonKrylovStep< Real >::NewtonKrylovStep(), ROL::PrimalDualActiveSetStep< Real >::PrimalDualActiveSetStep(), ROL::ProjectedNewtonKrylovStep< Real >::ProjectedNewtonKrylovStep(), ROL::ProjectedSecantStep< Real >::ProjectedSecantStep(), SecantFactory(), ROL::SecantStep< Real >::SecantStep(), and ROL::TrustRegionStep< Real >::TrustRegionStep().
|
inline |
Definition at line 501 of file ROL_Types.hpp.
References KRYLOV_CG, KRYLOV_CR, KRYLOV_GMRES, KRYLOV_LAST, and KRYLOV_USERDEFINED.
Referenced by ROL::NewtonKrylovStep< Real >::printName(), ROL::ProjectedNewtonKrylovStep< Real >::printName(), and StringToEKrylov().
|
inline |
Verifies validity of a Secant enum.
tr | [in] - enum of the Secant |
Definition at line 519 of file ROL_Types.hpp.
References KRYLOV_CG, KRYLOV_CR, KRYLOV_GMRES, and KRYLOV_USERDEFINED.
Definition at line 526 of file ROL_Types.hpp.
Definition at line 530 of file ROL_Types.hpp.
Definition at line 536 of file ROL_Types.hpp.
Definition at line 540 of file ROL_Types.hpp.
|
inline |
Definition at line 546 of file ROL_Types.hpp.
References EKrylovToString(), KRYLOV_CG, KRYLOV_LAST, and removeStringFormat().
Referenced by KrylovFactory(), ROL::NewtonKrylovStep< Real >::NewtonKrylovStep(), and ROL::ProjectedNewtonKrylovStep< Real >::ProjectedNewtonKrylovStep().
|
inline |
Definition at line 583 of file ROL_Types.hpp.
References NONLINEARCG_DAI_YUAN, NONLINEARCG_DANIEL, NONLINEARCG_FLETCHER_CONJDESC, NONLINEARCG_FLETCHER_REEVES, NONLINEARCG_HAGER_ZHANG, NONLINEARCG_HESTENES_STIEFEL, NONLINEARCG_LAST, NONLINEARCG_LIU_STOREY, NONLINEARCG_OREN_LUENBERGER, NONLINEARCG_POLAK_RIBIERE, and NONLINEARCG_USERDEFINED.
Referenced by ROL::NonlinearCGStep< Real >::printName(), and StringToENonlinearCG().
|
inline |
Verifies validity of a NonlinearCG enum.
tr | [in] - enum of the NonlinearCG |
Definition at line 607 of file ROL_Types.hpp.
References NONLINEARCG_DAI_YUAN, NONLINEARCG_DANIEL, NONLINEARCG_FLETCHER_CONJDESC, NONLINEARCG_FLETCHER_REEVES, NONLINEARCG_HAGER_ZHANG, NONLINEARCG_HESTENES_STIEFEL, NONLINEARCG_LIU_STOREY, NONLINEARCG_OREN_LUENBERGER, NONLINEARCG_POLAK_RIBIERE, and NONLINEARCG_USERDEFINED.
|
inline |
Definition at line 621 of file ROL_Types.hpp.
|
inline |
Definition at line 625 of file ROL_Types.hpp.
|
inline |
Definition at line 631 of file ROL_Types.hpp.
|
inline |
Definition at line 635 of file ROL_Types.hpp.
|
inline |
Definition at line 641 of file ROL_Types.hpp.
References ENonlinearCGToString(), NONLINEARCG_HESTENES_STIEFEL, NONLINEARCG_LAST, and removeStringFormat().
Referenced by ROL::NonlinearCGStep< Real >::NonlinearCGStep().
|
inline |
Definition at line 673 of file ROL_Types.hpp.
References LINESEARCH_BACKTRACKING, LINESEARCH_BISECTION, LINESEARCH_BRENTS, LINESEARCH_CUBICINTERP, LINESEARCH_GOLDENSECTION, LINESEARCH_ITERATIONSCALING, LINESEARCH_LAST, LINESEARCH_PATHBASEDTARGETLEVEL, and LINESEARCH_USERDEFINED.
Referenced by main(), ROL::LineSearchStep< Real >::printName(), and StringToELineSearch().
|
inline |
Verifies validity of a LineSearch enum.
ls | [in] - enum of the linesearch |
Definition at line 695 of file ROL_Types.hpp.
References LINESEARCH_BACKTRACKING, LINESEARCH_BISECTION, LINESEARCH_BRENTS, LINESEARCH_CUBICINTERP, LINESEARCH_GOLDENSECTION, LINESEARCH_ITERATIONSCALING, LINESEARCH_PATHBASEDTARGETLEVEL, and LINESEARCH_USERDEFINED.
|
inline |
Definition at line 707 of file ROL_Types.hpp.
|
inline |
Definition at line 711 of file ROL_Types.hpp.
|
inline |
Definition at line 717 of file ROL_Types.hpp.
|
inline |
Definition at line 721 of file ROL_Types.hpp.
|
inline |
Definition at line 727 of file ROL_Types.hpp.
References ELineSearchToString(), LINESEARCH_ITERATIONSCALING, LINESEARCH_LAST, and removeStringFormat().
Referenced by LineSearchFactory(), and ROL::LineSearchStep< Real >::LineSearchStep().
|
inline |
Definition at line 754 of file ROL_Types.hpp.
References CURVATURECONDITION_APPROXIMATEWOLFE, CURVATURECONDITION_GENERALIZEDWOLFE, CURVATURECONDITION_GOLDSTEIN, CURVATURECONDITION_LAST, CURVATURECONDITION_NULL, CURVATURECONDITION_STRONGWOLFE, and CURVATURECONDITION_WOLFE.
Referenced by ROL::LineSearchStep< Real >::printName(), and StringToECurvatureCondition().
|
inline |
Verifies validity of a CurvatureCondition enum.
ls | [in] - enum of the Curvature Conditions |
Definition at line 774 of file ROL_Types.hpp.
References CURVATURECONDITION_APPROXIMATEWOLFE, CURVATURECONDITION_GENERALIZEDWOLFE, CURVATURECONDITION_GOLDSTEIN, CURVATURECONDITION_NULL, CURVATURECONDITION_STRONGWOLFE, and CURVATURECONDITION_WOLFE.
|
inline |
Definition at line 784 of file ROL_Types.hpp.
|
inline |
Definition at line 788 of file ROL_Types.hpp.
|
inline |
Definition at line 794 of file ROL_Types.hpp.
|
inline |
Definition at line 798 of file ROL_Types.hpp.
|
inline |
Definition at line 804 of file ROL_Types.hpp.
References CURVATURECONDITION_LAST, CURVATURECONDITION_WOLFE, ECurvatureConditionToString(), and removeStringFormat().
Referenced by ROL::LineSearch< Real >::LineSearch(), ROL::LineSearchStep< Real >::LineSearchStep(), and ROL::ScalarMinimizationLineSearch< Real >::ScalarMinimizationLineSearch().
|
inline |
Definition at line 832 of file ROL_Types.hpp.
References CG_FLAG_ITEREXCEED, CG_FLAG_NEGCURVE, CG_FLAG_SUCCESS, and CG_FLAG_TRRADEX.
Referenced by ROL::TrustRegionStep< Real >::printHeader().
|
inline |
Definition at line 876 of file ROL_Types.hpp.
References TESTOBJECTIVES_BEALE, TESTOBJECTIVES_FREUDENSTEINANDROTH, TESTOBJECTIVES_LAST, TESTOBJECTIVES_LEASTSQUARES, TESTOBJECTIVES_POISSONCONTROL, TESTOBJECTIVES_POISSONINVERSION, TESTOBJECTIVES_POWELL, TESTOBJECTIVES_ROSENBROCK, TESTOBJECTIVES_SUMOFSQUARES, and TESTOBJECTIVES_ZAKHAROV.
Referenced by main(), and StringToETestObjectives().
|
inline |
Verifies validity of a TestObjectives enum.
ls | [in] - enum of the TestObjectives |
Definition at line 899 of file ROL_Types.hpp.
References TESTOBJECTIVES_BEALE, TESTOBJECTIVES_FREUDENSTEINANDROTH, TESTOBJECTIVES_LEASTSQUARES, TESTOBJECTIVES_POISSONCONTROL, TESTOBJECTIVES_POISSONINVERSION, TESTOBJECTIVES_POWELL, TESTOBJECTIVES_ROSENBROCK, TESTOBJECTIVES_SUMOFSQUARES, and TESTOBJECTIVES_ZAKHAROV.
|
inline |
Definition at line 912 of file ROL_Types.hpp.
|
inline |
Definition at line 916 of file ROL_Types.hpp.
|
inline |
Definition at line 922 of file ROL_Types.hpp.
|
inline |
Definition at line 926 of file ROL_Types.hpp.
|
inline |
Definition at line 932 of file ROL_Types.hpp.
References ETestObjectivesToString(), removeStringFormat(), TESTOBJECTIVES_LAST, and TESTOBJECTIVES_ROSENBROCK.
|
inline |
Definition at line 965 of file ROL_Types.hpp.
References TESTOPTPROBLEM_BVP, TESTOPTPROBLEM_HS1, TESTOPTPROBLEM_HS2, TESTOPTPROBLEM_HS25, TESTOPTPROBLEM_HS3, TESTOPTPROBLEM_HS38, TESTOPTPROBLEM_HS4, TESTOPTPROBLEM_HS45, TESTOPTPROBLEM_HS5, and TESTOPTPROBLEM_LAST.
Referenced by main(), and StringToETestOptProblem().
|
inline |
Verifies validity of a TestOptProblem enum.
ls | [in] - enum of the TestOptProblem |
Definition at line 988 of file ROL_Types.hpp.
References TESTOPTPROBLEM_BVP, TESTOPTPROBLEM_HS1, TESTOPTPROBLEM_HS2, TESTOPTPROBLEM_HS25, TESTOPTPROBLEM_HS3, TESTOPTPROBLEM_HS38, TESTOPTPROBLEM_HS4, TESTOPTPROBLEM_HS45, and TESTOPTPROBLEM_HS5.
|
inline |
Definition at line 1000 of file ROL_Types.hpp.
|
inline |
Definition at line 1004 of file ROL_Types.hpp.
|
inline |
Definition at line 1010 of file ROL_Types.hpp.
|
inline |
Definition at line 1014 of file ROL_Types.hpp.
|
inline |
Definition at line 1020 of file ROL_Types.hpp.
References ETestOptProblemToString(), removeStringFormat(), TESTOPTPROBLEM_HS1, and TESTOPTPROBLEM_LAST.
|
inline |
Definition at line 1043 of file ROL_Types.hpp.
References CONSTRAINT_EQUALITY, CONSTRAINT_INEQUALITY, and CONSTRAINT_LAST.
Referenced by StringToEConstraint().
|
inline |
Verifies validity of a Secant enum.
c | [in] - enum of the Secant |
Definition at line 1059 of file ROL_Types.hpp.
References CONSTRAINT_EQUALITY, and CONSTRAINT_INEQUALITY.
|
inline |
Definition at line 1064 of file ROL_Types.hpp.
|
inline |
Definition at line 1068 of file ROL_Types.hpp.
|
inline |
Definition at line 1074 of file ROL_Types.hpp.
|
inline |
Definition at line 1078 of file ROL_Types.hpp.
|
inline |
Definition at line 1084 of file ROL_Types.hpp.
References CONSTRAINT_EQUALITY, CONSTRAINT_LAST, EConstraintToString(), and removeStringFormat().
Real ROL::rol_cast | ( | const Element & | val | ) |
Definition at line 1140 of file ROL_Types.hpp.
References ROL::TypeCaster< Real, Element >::ElementToReal().
void ROL::addJSONBlockToPL | ( | const Json::Value & | block, |
Teuchos::ParameterList & | parlist | ||
) |
Iterate over a block and insert key-value pairs into the Teuchos::ParameterList.
[in] | block | is a block from a JSON object |
[in/out] | parlist is a Teuchos::ParameterList |
Definition at line 117 of file json/example_01.hpp.
References addJSONPairToPL().
Referenced by addJSONPairToPL(), and JSON_Parameters().
void ROL::addJSONPairToPL | ( | const Json::Value & | block, |
const std::string & | key, | ||
Teuchos::ParameterList & | parlist | ||
) |
Given a JSON block and a key, get the value and insert the key-value pair into a Teuchos::ParameterList. If the value is itself a block, recursively iterate.
[in] | block | is a block from a JSON object |
[in] | key | is a string key |
[in/out] | parlist is a Teuchos::ParameterList |
Definition at line 86 of file json/example_01.hpp.
References addJSONBlockToPL().
Referenced by addJSONBlockToPL().
void ROL::JSON_Parameters | ( | const std::string & | jsonFileName, |
Teuchos::ParameterList & | parlist | ||
) |
Read a JSON file and store all parameters in a Teuchos::ParameterList. Checks for a key called "Algorithm" which has a string value which can specify a Step Type (Linesearch or Trust-Region) and either a Descent Type or a Trust-Region Subproblem Solver Type.
[in] | block | is a block from a JSON object |
[in/out] | parlist is a Teuchos::ParameterList |
Definition at line 136 of file json/example_01.hpp.
References addJSONBlockToPL().
Referenced by main().
void ROL::stepFactory | ( | Teuchos::ParameterList & | parlist, |
Teuchos::RCP< ROL::Step< Real > > & | step | ||
) |
A minimalist step factory which specializes the Step Type depending on whether a Trust-Region or Linesearch has been selected.
[in] | parlist | is a Teuchos::ParameterList |
[in/out] | step is a ref count pointer to a ROL::Step |
Definition at line 207 of file json/example_01.hpp.
Referenced by ROL::Algorithm< Real >::Algorithm(), and main().