ROL
Namespaces | Classes | Enumerations | Functions
ROL Namespace Reference

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...
 

Enumerations

enum  ETrustRegion {
  TRUSTREGION_CAUCHYPOINT = 0, TRUSTREGION_TRUNCATEDCG, TRUSTREGION_DOGLEG, TRUSTREGION_DOUBLEDOGLEG,
  TRUSTREGION_LAST
}
 Enumeration of trust-region solver types. More...
 
enum  ETrustRegionModel { TRUSTREGION_MODEL_COLEMANLI = 0, TRUSTREGION_MODEL_KELLEYSACHS, TRUSTREGION_MODEL_LAST }
 Enumeration of trust-region model types. More...
 
enum  ETrustRegionFlag {
  TRUSTREGION_FLAG_SUCCESS = 0, TRUSTREGION_FLAG_POSPREDNEG, TRUSTREGION_FLAG_NPOSPREDPOS, TRUSTREGION_FLAG_NPOSPREDNEG,
  TRUSTREGION_FLAG_QMINSUFDEC, TRUSTREGION_FLAG_NAN, TRUSTREGION_FLAG_UNDEFINED
}
 Enumation of flags used by trust-region solvers. More...
 
enum  EDistribution {
  DISTRIBUTION_ARCSINE = 0, 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, DISTRIBUTION_LAST
}
 
enum  ERiskMeasure {
  RISKMEASURE_CVAR = 0, RISKMEASURE_COHERENTEXPUTILITY, RISKMEASURE_EXPUTILITY, RISKMEASURE_HMCR,
  RISKMEASURE_MEANDEVIATIONFROMTARGET, RISKMEASURE_MEANDEVIATION, RISKMEASURE_MEANVARIANCEFROMTARGET, RISKMEASURE_MEANVARIANCE,
  RISKMEASURE_MOREAUYOSIDACVAR, RISKMEASURE_LOGEXPONENTIALQUADRANGLE, RISKMEASURE_LOGQUANTILEQUADRANGLE, RISKMEASURE_MEANVARIANCEQUADRANGLE,
  RISKMEASURE_MIXEDQUANTILEQUADRANGLE, RISKMEASURE_QUANTILEQUADRANGLE, RISKMEASURE_QUANTILERADIUSQUADRANGLE, RISKMEASURE_SMOOTHEDWORSTCASEQUADRANGLE,
  RISKMEASURE_SUPERQUANTILEQUADRANGLE, RISKMEASURE_CHEBYSHEVKUSUOKA, RISKMEASURE_SPECTRALRISK, RISKMEASURE_TRUNCATEDMEANQUADRANGLE,
  RISKMEASURE_CHI2DIVERGENCE, RISKMEASURE_KLDIVERGENCE, RISKMEASURE_LAST
}
 
enum  EAbsoluteValue {
  ABSOLUTEVALUE_TRUE = 0, ABSOLUTEVALUE_SQUAREROOT, ABSOLUTEVALUE_SQRTDENOM, ABSOLUTEVALUE_C2,
  ABSOLUTEVALUE_LAST
}
 
enum  EStep {
  STEP_AUGMENTEDLAGRANGIAN = 0, STEP_BUNDLE, STEP_COMPOSITESTEP, STEP_LINESEARCH,
  STEP_MOREAUYOSIDAPENALTY, STEP_PRIMALDUALACTIVESET, STEP_TRUSTREGION, STEP_INTERIORPOINT,
  STEP_LAST
}
 Enumeration of step types. More...
 
enum  EBoundAlgorithm { BOUNDALGORITHM_PROJECTED = 0, BOUNDALGORITHM_PRIMALDUALACTIVESET, BOUNDALGORITHM_INTERIORPOINTS, BOUNDALGORITHM_LAST }
 Enumeration of algorithms to handle bound constraints. More...
 
enum  EDescent {
  DESCENT_STEEPEST = 0, DESCENT_NONLINEARCG, DESCENT_SECANT, DESCENT_NEWTON,
  DESCENT_NEWTONKRYLOV, DESCENT_LAST
}
 Enumeration of descent direction types. More...
 
enum  ESecant {
  SECANT_LBFGS = 0, SECANT_LDFP, SECANT_LSR1, SECANT_BARZILAIBORWEIN,
  SECANT_USERDEFINED, SECANT_LAST
}
 Enumeration of secant update algorithms. More...
 
enum  EKrylov {
  KRYLOV_CG = 0, KRYLOV_CR, KRYLOV_GMRES, KRYLOV_USERDEFINED,
  KRYLOV_LAST
}
 Enumeration of Krylov methods. More...
 
enum  ENonlinearCG {
  NONLINEARCG_HESTENES_STIEFEL = 0, NONLINEARCG_FLETCHER_REEVES, NONLINEARCG_DANIEL, NONLINEARCG_POLAK_RIBIERE,
  NONLINEARCG_FLETCHER_CONJDESC, NONLINEARCG_LIU_STOREY, NONLINEARCG_DAI_YUAN, NONLINEARCG_HAGER_ZHANG,
  NONLINEARCG_OREN_LUENBERGER, NONLINEARCG_USERDEFINED, NONLINEARCG_LAST
}
 Enumeration of nonlinear CG algorithms. More...
 
enum  ELineSearch {
  LINESEARCH_ITERATIONSCALING = 0, LINESEARCH_PATHBASEDTARGETLEVEL, LINESEARCH_BACKTRACKING, LINESEARCH_BISECTION,
  LINESEARCH_GOLDENSECTION, LINESEARCH_CUBICINTERP, LINESEARCH_BRENTS, LINESEARCH_USERDEFINED,
  LINESEARCH_LAST
}
 Enumeration of line-search types. More...
 
enum  ECurvatureCondition {
  CURVATURECONDITION_WOLFE = 0, CURVATURECONDITION_STRONGWOLFE, CURVATURECONDITION_GENERALIZEDWOLFE, CURVATURECONDITION_APPROXIMATEWOLFE,
  CURVATURECONDITION_GOLDSTEIN, CURVATURECONDITION_NULL, CURVATURECONDITION_LAST
}
 Enumeration of line-search curvature conditions. More...
 
enum  ECGFlag {
  CG_FLAG_SUCCESS = 0, CG_FLAG_ITEREXCEED, CG_FLAG_NEGCURVE, CG_FLAG_TRRADEX,
  CG_FLAG_UNDEFINED
}
 Enumation of flags used by conjugate gradient methods. More...
 
enum  ETestObjectives {
  TESTOBJECTIVES_ROSENBROCK = 0, TESTOBJECTIVES_FREUDENSTEINANDROTH, TESTOBJECTIVES_BEALE, TESTOBJECTIVES_POWELL,
  TESTOBJECTIVES_SUMOFSQUARES, TESTOBJECTIVES_LEASTSQUARES, TESTOBJECTIVES_POISSONCONTROL, TESTOBJECTIVES_POISSONINVERSION,
  TESTOBJECTIVES_ZAKHAROV, TESTOBJECTIVES_LAST
}
 Enumeration of test objective functions. More...
 
enum  ETestOptProblem {
  TESTOPTPROBLEM_HS1 = 0, TESTOPTPROBLEM_HS2, TESTOPTPROBLEM_HS3, TESTOPTPROBLEM_HS4,
  TESTOPTPROBLEM_HS5, TESTOPTPROBLEM_HS25, TESTOPTPROBLEM_HS38, TESTOPTPROBLEM_HS45,
  TESTOPTPROBLEM_BVP, TESTOPTPROBLEM_LAST
}
 Enumeration of test optimization problems. More...
 
enum  EConstraint { CONSTRAINT_EQUALITY = 0, CONSTRAINT_INEQUALITY, CONSTRAINT_LAST }
 Enumeration of constraint types. 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...
 
ETrustRegionoperator++ (ETrustRegion &type)
 
ETrustRegion operator++ (ETrustRegion &type, int)
 
ETrustRegionoperator-- (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...
 
ETrustRegionModeloperator++ (ETrustRegionModel &type)
 
ETrustRegionModel operator++ (ETrustRegionModel &type, int)
 
ETrustRegionModeloperator-- (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)
 
EDistributionoperator++ (EDistribution &type)
 
EDistribution operator++ (EDistribution &type, int)
 
EDistributionoperator-- (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)
 
ERiskMeasureoperator++ (ERiskMeasure &type)
 
ERiskMeasure operator++ (ERiskMeasure &type, int)
 
ERiskMeasureoperator-- (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...
 
EStepoperator++ (EStep &type)
 
EStep operator++ (EStep &type, int)
 
EStepoperator-- (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...
 
EBoundAlgorithmoperator++ (EBoundAlgorithm &type)
 
EBoundAlgorithm operator++ (EBoundAlgorithm &type, int)
 
EBoundAlgorithmoperator-- (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...
 
EDescentoperator++ (EDescent &type)
 
EDescent operator++ (EDescent &type, int)
 
EDescentoperator-- (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...
 
ESecantoperator++ (ESecant &type)
 
ESecant operator++ (ESecant &type, int)
 
ESecantoperator-- (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...
 
EKrylovoperator++ (EKrylov &type)
 
EKrylov operator++ (EKrylov &type, int)
 
EKrylovoperator-- (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...
 
ENonlinearCGoperator++ (ENonlinearCG &type)
 
ENonlinearCG operator++ (ENonlinearCG &type, int)
 
ENonlinearCGoperator-- (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...
 
ELineSearchoperator++ (ELineSearch &type)
 
ELineSearch operator++ (ELineSearch &type, int)
 
ELineSearchoperator-- (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...
 
ECurvatureConditionoperator++ (ECurvatureCondition &type)
 
ECurvatureCondition operator++ (ECurvatureCondition &type, int)
 
ECurvatureConditionoperator-- (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...
 
ETestObjectivesoperator++ (ETestObjectives &type)
 
ETestObjectives operator++ (ETestObjectives &type, int)
 
ETestObjectivesoperator-- (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...
 
ETestOptProblemoperator++ (ETestOptProblem &type)
 
ETestOptProblem operator++ (ETestOptProblem &type, int)
 
ETestOptProblemoperator-- (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...
 
EConstraintoperator++ (EConstraint &type)
 
EConstraint operator++ (EConstraint &type, int)
 
EConstraintoperator-- (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...
 

Enumeration Type Documentation

◆ ETrustRegion

Enumeration of trust-region solver types.

  • CAUCHYPOINT describe
  • TRUNCATEDCG describe
  • DOGLEG describe
  • DOUBLEDOGLEG describe
Enumerator
TRUSTREGION_CAUCHYPOINT 
TRUSTREGION_TRUNCATEDCG 
TRUSTREGION_DOGLEG 
TRUSTREGION_DOUBLEDOGLEG 
TRUSTREGION_LAST 

Definition at line 62 of file ROL_TrustRegionTypes.hpp.

◆ ETrustRegionModel

Enumeration of trust-region model types.

  • COLEMANLI describe
  • KELLEYSACHS describe
Enumerator
TRUSTREGION_MODEL_COLEMANLI 
TRUSTREGION_MODEL_KELLEYSACHS 
TRUSTREGION_MODEL_LAST 

Definition at line 132 of file ROL_TrustRegionTypes.hpp.

◆ ETrustRegionFlag

Enumation of flags used by trust-region solvers.

  • TRUSTREGION_FLAG_SUCCESS Actual and predicted reductions are positive
  • TRUSTREGION_FLAG_POSPREDNEG Reduction is positive, predicted negative (impossible)
  • TRUSTREGION_FLAG_NPOSPREDPOS Reduction is nonpositive, predicted positive
  • TRUSTREGION_FLAG_NPOSPREDNEG Reduction is nonpositive, predicted negative (impossible)
  • TRUSTREGION_FLAG_QMINSUFDEC Insufficient decrease of the quadratic model (bound constraint only)
  • TRUSTREGION_FLAG_NAN Actual and/or predicted reduction is NaN
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.

◆ EDistribution

Enumerator
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 
DISTRIBUTION_LAST 

Definition at line 69 of file ROL_DistributionFactory.hpp.

◆ ERiskMeasure

Enumerator
RISKMEASURE_CVAR 
RISKMEASURE_COHERENTEXPUTILITY 
RISKMEASURE_EXPUTILITY 
RISKMEASURE_HMCR 
RISKMEASURE_MEANDEVIATIONFROMTARGET 
RISKMEASURE_MEANDEVIATION 
RISKMEASURE_MEANVARIANCEFROMTARGET 
RISKMEASURE_MEANVARIANCE 
RISKMEASURE_MOREAUYOSIDACVAR 
RISKMEASURE_LOGEXPONENTIALQUADRANGLE 
RISKMEASURE_LOGQUANTILEQUADRANGLE 
RISKMEASURE_MEANVARIANCEQUADRANGLE 
RISKMEASURE_MIXEDQUANTILEQUADRANGLE 
RISKMEASURE_QUANTILEQUADRANGLE 
RISKMEASURE_QUANTILERADIUSQUADRANGLE 
RISKMEASURE_SMOOTHEDWORSTCASEQUADRANGLE 
RISKMEASURE_SUPERQUANTILEQUADRANGLE 
RISKMEASURE_CHEBYSHEVKUSUOKA 
RISKMEASURE_SPECTRALRISK 
RISKMEASURE_TRUNCATEDMEANQUADRANGLE 
RISKMEASURE_CHI2DIVERGENCE 
RISKMEASURE_KLDIVERGENCE 
RISKMEASURE_LAST 

Definition at line 81 of file ROL_RiskMeasureFactory.hpp.

◆ EAbsoluteValue

Enumerator
ABSOLUTEVALUE_TRUE 
ABSOLUTEVALUE_SQUAREROOT 
ABSOLUTEVALUE_SQRTDENOM 
ABSOLUTEVALUE_C2 
ABSOLUTEVALUE_LAST 

Definition at line 52 of file ROL_AbsoluteValue.hpp.

◆ EStep

enum ROL::EStep

Enumeration of step types.

  • AUGMENTEDLAGRANGIAN describe
  • BUNDLE describe
  • COMPOSITESTEP describe
  • LINESEARCH describe
  • MOREAUYOSIDAPENALTY describe
  • PRIMALDUALACTIVESET describe
  • TRUSTREGION describe
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.

◆ EBoundAlgorithm

Enumeration of algorithms to handle bound constraints.

  • PROJECTED describe
  • PRIMALDUALACTIVESET describe
  • INTERIORPOINTS describe
Enumerator
BOUNDALGORITHM_PROJECTED 
BOUNDALGORITHM_PRIMALDUALACTIVESET 
BOUNDALGORITHM_INTERIORPOINTS 
BOUNDALGORITHM_LAST 

Definition at line 274 of file ROL_Types.hpp.

◆ EDescent

Enumeration of descent direction types.

  • STEEPEST describe
  • NONLINEARCG describe
  • SECANT describe
  • NEWTON describe
  • NEWTONKRYLOV describe
  • SECANTPRECOND describe
Enumerator
DESCENT_STEEPEST 
DESCENT_NONLINEARCG 
DESCENT_SECANT 
DESCENT_NEWTON 
DESCENT_NEWTONKRYLOV 
DESCENT_LAST 

Definition at line 345 of file ROL_Types.hpp.

◆ ESecant

Enumeration of secant update algorithms.

  • LBFGS describe
  • LDFP describe
  • LSR1 describe
  • BARZILAIBORWEIN describe
Enumerator
SECANT_LBFGS 
SECANT_LDFP 
SECANT_LSR1 
SECANT_BARZILAIBORWEIN 
SECANT_USERDEFINED 
SECANT_LAST 

Definition at line 420 of file ROL_Types.hpp.

◆ EKrylov

Enumeration of Krylov methods.

  • CG describe
  • CR describe
Enumerator
KRYLOV_CG 
KRYLOV_CR 
KRYLOV_GMRES 
KRYLOV_USERDEFINED 
KRYLOV_LAST 

Definition at line 493 of file ROL_Types.hpp.

◆ ENonlinearCG

Enumeration of nonlinear CG algorithms.

  • HESTENES_STIEFEL \( \frac{g_{k+1}^\top y_k}{d_k^\top y_k } \)
  • FLETCHER_REEVES \( \frac{\|g_{k+1}\|^2}{\|g_k\|^2} \)
  • DANIEL \( \frac{g_{k+1}^\top \nabla^2 f(x_k) d_k}{d_k^\top \nabla^2 f(x_k) d_k} \)
  • POLAK_RIBIERE \( \frac{g_{k+1}^\top y_k}{\|g_k\|^2} \)
  • FLETCHER_CONJDESC \( -\frac{\|g_{k+1}\|^2}{d_k^\top g_k} \)
  • LIU_STOREY \( -\frac{g_k^\top y_{k-1} }{d_{k-1}^\top g_{k-1} \)
  • DAI_YUAN \( \frac{\|g_{k+1}\|^2}{d_k^\top y_k} \)
  • HAGER_ZHANG \( \frac{g_{k+1}^\top y_k}{d_k^\top y_k} - 2 \frac{\|y_k\|^2}{d_k^\top y_k} \frac{g_{k+1}^\top d_k}{d_k^\top y_k} \)
  • OREN_LUENBERGER \( \frac{g_{k+1}^\top y_k}{d_k^\top y_k} - \frac{\|y_k\|^2}{d_k^\top y_k} \frac{g_{k+1}^\top d_k}{d_k^\top y_k} \)
Enumerator
NONLINEARCG_HESTENES_STIEFEL 
NONLINEARCG_FLETCHER_REEVES 
NONLINEARCG_DANIEL 
NONLINEARCG_POLAK_RIBIERE 
NONLINEARCG_FLETCHER_CONJDESC 
NONLINEARCG_LIU_STOREY 
NONLINEARCG_DAI_YUAN 
NONLINEARCG_HAGER_ZHANG 
NONLINEARCG_OREN_LUENBERGER 
NONLINEARCG_USERDEFINED 
NONLINEARCG_LAST 

Definition at line 569 of file ROL_Types.hpp.

◆ ELineSearch

Enumeration of line-search types.

  • BACKTRACKING describe
  • BISECTION describe
  • GOLDENSECTION describe
  • CUBICINTERP describe
  • BRENTS describe
  • USERDEFINED describe
Enumerator
LINESEARCH_ITERATIONSCALING 
LINESEARCH_PATHBASEDTARGETLEVEL 
LINESEARCH_BACKTRACKING 
LINESEARCH_BISECTION 
LINESEARCH_GOLDENSECTION 
LINESEARCH_CUBICINTERP 
LINESEARCH_BRENTS 
LINESEARCH_USERDEFINED 
LINESEARCH_LAST 

Definition at line 661 of file ROL_Types.hpp.

◆ ECurvatureCondition

Enumeration of line-search curvature conditions.

  • WOLFE describe
  • STRONGWOLFE describe
  • GOLDSTEIN describe
Enumerator
CURVATURECONDITION_WOLFE 
CURVATURECONDITION_STRONGWOLFE 
CURVATURECONDITION_GENERALIZEDWOLFE 
CURVATURECONDITION_APPROXIMATEWOLFE 
CURVATURECONDITION_GOLDSTEIN 
CURVATURECONDITION_NULL 
CURVATURECONDITION_LAST 

Definition at line 744 of file ROL_Types.hpp.

◆ ECGFlag

Enumation of flags used by conjugate gradient methods.

  • CG_FLAG_SUCCESS Residual Tolerance Met
  • CG_FLAG_ITEREXCEED Iteration Limit Exceeded
  • CG_FLAG_NEGCURVE Negative Curvature Detected CG_FLAG_TRRADEX Trust-Region Radius Exceeded
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.

◆ ETestObjectives

Enumeration of test objective functions.

  • ROSENBROCK describe
  • FREUDENSTEINANDROTH describe
  • POWELL describe
  • SUMOFSQUARES describe
  • LEASTSQUARES describe
Enumerator
TESTOBJECTIVES_ROSENBROCK 
TESTOBJECTIVES_FREUDENSTEINANDROTH 
TESTOBJECTIVES_BEALE 
TESTOBJECTIVES_POWELL 
TESTOBJECTIVES_SUMOFSQUARES 
TESTOBJECTIVES_LEASTSQUARES 
TESTOBJECTIVES_POISSONCONTROL 
TESTOBJECTIVES_POISSONINVERSION 
TESTOBJECTIVES_ZAKHAROV 
TESTOBJECTIVES_LAST 

Definition at line 863 of file ROL_Types.hpp.

◆ ETestOptProblem

Enumeration of test optimization problems.

  • HS1 describe
  • HS2 describe
  • HS3 describe
  • HS4 describe
  • HS5 describe
  • HS25 describe
Enumerator
TESTOPTPROBLEM_HS1 
TESTOPTPROBLEM_HS2 
TESTOPTPROBLEM_HS3 
TESTOPTPROBLEM_HS4 
TESTOPTPROBLEM_HS5 
TESTOPTPROBLEM_HS25 
TESTOPTPROBLEM_HS38 
TESTOPTPROBLEM_HS45 
TESTOPTPROBLEM_BVP 
TESTOPTPROBLEM_LAST 

Definition at line 952 of file ROL_Types.hpp.

◆ EConstraint

Enumeration of constraint types.

  • EQUALITY describe
  • INEQUALITY describe
Enumerator
CONSTRAINT_EQUALITY 
CONSTRAINT_INEQUALITY 
CONSTRAINT_LAST 

Definition at line 1037 of file ROL_Types.hpp.

Function Documentation

◆ CreatePartitionedVector() [1/8]

template<class Real >
Teuchos::RCP<Vector<Real> > ROL::CreatePartitionedVector ( const Teuchos::RCP< Vector< Real > > &  a)

◆ CreatePartitionedVector() [2/8]

template<class Real >
Teuchos::RCP<const Vector<Real> > ROL::CreatePartitionedVector ( const Teuchos::RCP< const Vector< Real > > &  a)

Definition at line 279 of file ROL_PartitionedVector.hpp.

◆ CreatePartitionedVector() [3/8]

template<class Real >
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.

◆ CreatePartitionedVector() [4/8]

template<class Real >
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.

◆ CreatePartitionedVector() [5/8]

template<class Real >
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.

◆ CreatePartitionedVector() [6/8]

template<class Real >
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.

◆ CreatePartitionedVector() [7/8]

template<class Real >
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.

◆ CreatePartitionedVector() [8/8]

template<class Real >
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.

◆ CreateBoundConstraint_Partitioned()

template<class Real >
Teuchos::RCP<BoundConstraint<Real> > ROL::CreateBoundConstraint_Partitioned ( const Teuchos::RCP< BoundConstraint< Real > > &  bnd1,
const Teuchos::RCP< BoundConstraint< Real > > &  bnd2 
)

◆ CreateEqualityConstraintPartitioned() [1/2]

template<class Real >
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().

◆ CreateEqualityConstraintPartitioned() [2/2]

template<class Real >
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.

◆ normL1()

template<class Real >
Real ROL::normL1 ( const Vector< Real > &  x)

Definition at line 52 of file ROL_VectorNorms.hpp.

References ROL::Vector< Real >::clone().

◆ normLp()

template<class Real , class Exponent >
Real ROL::normLp ( const Vector< Real > &  x,
Exponent  p 
)

Definition at line 62 of file ROL_VectorNorms.hpp.

References ROL::Vector< Real >::clone().

◆ normLinf()

template<class Real >
Real ROL::normLinf ( const Vector< Real > &  x)

Definition at line 73 of file ROL_VectorNorms.hpp.

References ROL::Vector< Real >::clone().

◆ KrylovFactory()

template<class Real >
Teuchos::RCP<Krylov<Real> > ROL::KrylovFactory ( Teuchos::ParameterList &  parlist)
inline

Definition at line 63 of file ROL_KrylovFactory.hpp.

References KRYLOV_CG, KRYLOV_CR, KRYLOV_GMRES, and StringToEKrylov().

◆ LineSearchFactory()

template<class Real >
Teuchos::RCP<LineSearch<Real> > ROL::LineSearchFactory ( Teuchos::ParameterList &  parlist)
inline

◆ getSecant()

template<class Real >
Teuchos::RCP<Secant<Real> > ROL::getSecant ( ESecant  esec = SECANT_LBFGS,
int  L = 10,
int  BBtype = 1 
)
inline

Definition at line 60 of file ROL_SecantFactory.hpp.

References SECANT_BARZILAIBORWEIN, SECANT_LBFGS, SECANT_LDFP, and SECANT_LSR1.

◆ SecantFactory()

template<class Real >
Teuchos::RCP<Secant<Real> > ROL::SecantFactory ( Teuchos::ParameterList &  parlist)
inline

◆ TrustRegionFactory()

template<class Real >
Teuchos::RCP<TrustRegion<Real> > ROL::TrustRegionFactory ( Teuchos::ParameterList &  parlist)
inline

◆ ETrustRegionToString()

std::string ROL::ETrustRegionToString ( ETrustRegion  tr)
inline

◆ isValidTrustRegion()

int ROL::isValidTrustRegion ( ETrustRegion  ls)
inline

Verifies validity of a TrustRegion enum.

Parameters
tr[in] - enum of the TrustRegion
Returns
1 if the argument is a valid TrustRegion; 0 otherwise.

Definition at line 88 of file ROL_TrustRegionTypes.hpp.

References TRUSTREGION_CAUCHYPOINT, TRUSTREGION_DOGLEG, TRUSTREGION_DOUBLEDOGLEG, and TRUSTREGION_TRUNCATEDCG.

◆ operator++() [1/30]

ETrustRegion& ROL::operator++ ( ETrustRegion type)
inline

Definition at line 96 of file ROL_TrustRegionTypes.hpp.

◆ operator++() [2/30]

ETrustRegion ROL::operator++ ( ETrustRegion type,
int   
)
inline

Definition at line 100 of file ROL_TrustRegionTypes.hpp.

◆ operator--() [1/30]

ETrustRegion& ROL::operator-- ( ETrustRegion type)
inline

Definition at line 106 of file ROL_TrustRegionTypes.hpp.

◆ operator--() [2/30]

ETrustRegion ROL::operator-- ( ETrustRegion type,
int   
)
inline

Definition at line 110 of file ROL_TrustRegionTypes.hpp.

◆ StringToETrustRegion()

ETrustRegion ROL::StringToETrustRegion ( std::string  s)
inline

◆ ETrustRegionModelToString()

std::string ROL::ETrustRegionModelToString ( ETrustRegionModel  tr)
inline

◆ isValidTrustRegionModel()

int ROL::isValidTrustRegionModel ( ETrustRegionModel  ls)
inline

Verifies validity of a TrustRegionModel enum.

Parameters
tr[in] - enum of the TrustRegionModel
Returns
1 if the argument is a valid TrustRegionModel; 0 otherwise.

Definition at line 154 of file ROL_TrustRegionTypes.hpp.

References TRUSTREGION_MODEL_COLEMANLI, and TRUSTREGION_MODEL_KELLEYSACHS.

◆ operator++() [3/30]

ETrustRegionModel& ROL::operator++ ( ETrustRegionModel type)
inline

Definition at line 160 of file ROL_TrustRegionTypes.hpp.

◆ operator++() [4/30]

ETrustRegionModel ROL::operator++ ( ETrustRegionModel type,
int   
)
inline

Definition at line 164 of file ROL_TrustRegionTypes.hpp.

◆ operator--() [3/30]

ETrustRegionModel& ROL::operator-- ( ETrustRegionModel type)
inline

Definition at line 170 of file ROL_TrustRegionTypes.hpp.

◆ operator--() [4/30]

ETrustRegionModel ROL::operator-- ( ETrustRegionModel type,
int   
)
inline

Definition at line 174 of file ROL_TrustRegionTypes.hpp.

◆ StringToETrustRegionModel()

ETrustRegionModel ROL::StringToETrustRegionModel ( std::string  s)
inline

◆ ETrustRegionFlagToString()

std::string ROL::ETrustRegionFlagToString ( ETrustRegionFlag  trf)
inline

◆ EDistributionToString()

std::string ROL::EDistributionToString ( EDistribution  ed)
inline

◆ isValidDistribution()

int ROL::isValidDistribution ( EDistribution  ed)
inline

◆ operator++() [5/30]

EDistribution& ROL::operator++ ( EDistribution type)
inline

Definition at line 136 of file ROL_DistributionFactory.hpp.

◆ operator++() [6/30]

EDistribution ROL::operator++ ( EDistribution type,
int   
)
inline

Definition at line 140 of file ROL_DistributionFactory.hpp.

◆ operator--() [5/30]

EDistribution& ROL::operator-- ( EDistribution type)
inline

Definition at line 146 of file ROL_DistributionFactory.hpp.

◆ operator--() [6/30]

EDistribution ROL::operator-- ( EDistribution type,
int   
)
inline

Definition at line 150 of file ROL_DistributionFactory.hpp.

◆ StringToEDistribution()

EDistribution ROL::StringToEDistribution ( std::string  s)
inline

◆ DistributionFactory()

template<class Real >
Teuchos::RCP<Distribution<Real> > ROL::DistributionFactory ( Teuchos::ParameterList &  parlist)
inline

◆ ERiskMeasureToString()

std::string ROL::ERiskMeasureToString ( ERiskMeasure  ed)
inline

◆ isValidRiskMeasure()

int ROL::isValidRiskMeasure ( ERiskMeasure  ed)
inline

◆ operator++() [7/30]

ERiskMeasure& ROL::operator++ ( ERiskMeasure type)
inline

Definition at line 187 of file ROL_RiskMeasureFactory.hpp.

◆ operator++() [8/30]

ERiskMeasure ROL::operator++ ( ERiskMeasure type,
int   
)
inline

Definition at line 191 of file ROL_RiskMeasureFactory.hpp.

◆ operator--() [7/30]

ERiskMeasure& ROL::operator-- ( ERiskMeasure type)
inline

Definition at line 197 of file ROL_RiskMeasureFactory.hpp.

◆ operator--() [8/30]

ERiskMeasure ROL::operator-- ( ERiskMeasure type,
int   
)
inline

Definition at line 201 of file ROL_RiskMeasureFactory.hpp.

◆ StringToERiskMeasure()

ERiskMeasure ROL::StringToERiskMeasure ( std::string  s)
inline

◆ RiskMeasureFactory()

template<class Real >
Teuchos::RCP<RiskMeasure<Real> > ROL::RiskMeasureFactory ( Teuchos::ParameterList &  parlist)
inline

◆ RiskMeasureInfo()

template<class Real >
void ROL::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 
)
inline

Definition at line 53 of file ROL_RiskMeasureInfo.hpp.

◆ CreateSimulatedVector() [1/8]

template<class Real >
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.

◆ CreateSimulatedVector() [2/8]

template<class Real >
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.

◆ CreateSimulatedVector() [3/8]

template<class Real >
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.

◆ CreateSimulatedVector() [4/8]

template<class Real >
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.

◆ CreateSimulatedVector() [5/8]

template<class Real >
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.

◆ CreateSimulatedVector() [6/8]

template<class Real >
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.

◆ CreateSimulatedVector() [7/8]

template<class Real >
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.

◆ CreateSimulatedVector() [8/8]

template<class Real >
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.

◆ computeDenseHessian()

template<class Real >
Teuchos::SerialDenseMatrix<int, Real> ROL::computeDenseHessian ( Objective< Real > &  obj,
const Vector< Real > &  x 
)

◆ computeDotMatrix()

template<class Real >
Teuchos::SerialDenseMatrix<int, Real> ROL::computeDotMatrix ( const Vector< Real > &  x)

◆ computeEigenvalues()

template<class Real >
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().

◆ computeGenEigenvalues()

template<class Real >
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.

◆ computeInverse()

template<class Real >
Teuchos::SerialDenseMatrix<int, Real> ROL::computeInverse ( const Teuchos::SerialDenseMatrix< int, Real > &  mat)

Definition at line 194 of file ROL_HelperFunctions.hpp.

◆ setParameter()

template<class ParameterType >
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().

◆ tierParameterList()

void ROL::tierParameterList ( Teuchos::ParameterList &  outList,
const Teuchos::ParameterList &  inList 
)
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().

◆ getTestObjectives() [1/2]

template<class Real >
void ROL::getTestObjectives ( Teuchos::RCP< Objective< Real > > &  obj,
Teuchos::RCP< Vector< Real > > &  x0,
Teuchos::RCP< Vector< Real > > &  x,
const ETestObjectives  test 
)

◆ getTestObjectives() [2/2]

template<class Real >
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 
)

◆ NumberToString()

template<class T >
std::string ROL::NumberToString ( Number)

Definition at line 80 of file ROL_Types.hpp.

Referenced by ROL::TrustRegionStep< Real >::printHeader().

◆ ROL_EPSILON()

template<class Real >
Real ROL::ROL_EPSILON ( void  )
inline

Platform-dependent machine epsilon.

Definition at line 139 of file ROL_Types.hpp.

◆ ROL_THRESHOLD()

template<class Real >
Real ROL::ROL_THRESHOLD ( void  )
inline

Tolerance for various equality tests.

Definition at line 145 of file ROL_Types.hpp.

◆ ROL_OVERFLOW()

template<class Real >
Real ROL::ROL_OVERFLOW ( void  )
inline

Platform-dependent maximum double.

Definition at line 151 of file ROL_Types.hpp.

◆ ROL_INF()

template<class Real >
Real ROL::ROL_INF ( void  )
inline

Definition at line 155 of file ROL_Types.hpp.

◆ ROL_NINF()

template<class Real >
Real ROL::ROL_NINF ( void  )
inline

Definition at line 159 of file ROL_Types.hpp.

◆ ROL_UNDERFLOW()

template<class Real >
Real ROL::ROL_UNDERFLOW ( void  )
inline

Platform-dependent minimum double.

Definition at line 165 of file ROL_Types.hpp.

◆ removeStringFormat()

std::string ROL::removeStringFormat ( std::string  s)
inline

◆ EStepToString()

std::string ROL::EStepToString ( EStep  tr)
inline

◆ isValidStep()

int ROL::isValidStep ( EStep  ls)
inline

Verifies validity of a TrustRegion enum.

Parameters
tr[in] - enum of the TrustRegion
Returns
1 if the argument is a valid TrustRegion; 0 otherwise.

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().

◆ operator++() [9/30]

EStep& ROL::operator++ ( EStep type)
inline

Definition at line 237 of file ROL_Types.hpp.

◆ operator++() [10/30]

EStep ROL::operator++ ( EStep type,
int   
)
inline

Definition at line 241 of file ROL_Types.hpp.

◆ operator--() [9/30]

EStep& ROL::operator-- ( EStep type)
inline

Definition at line 247 of file ROL_Types.hpp.

◆ operator--() [10/30]

EStep ROL::operator-- ( EStep type,
int   
)
inline

Definition at line 251 of file ROL_Types.hpp.

◆ StringToEStep()

EStep ROL::StringToEStep ( std::string  s)
inline

◆ EBoundAlgorithmToString()

std::string ROL::EBoundAlgorithmToString ( EBoundAlgorithm  tr)
inline

◆ isValidBoundAlgorithm()

int ROL::isValidBoundAlgorithm ( EBoundAlgorithm  d)
inline

Verifies validity of a Bound Algorithm enum.

Parameters
tr[in] - enum of the Bound Algorithm
Returns
1 if the argument is a valid Bound Algorithm; 0 otherwise.

Definition at line 298 of file ROL_Types.hpp.

References BOUNDALGORITHM_INTERIORPOINTS, BOUNDALGORITHM_PRIMALDUALACTIVESET, and BOUNDALGORITHM_PROJECTED.

◆ operator++() [11/30]

EBoundAlgorithm& ROL::operator++ ( EBoundAlgorithm type)
inline

Definition at line 305 of file ROL_Types.hpp.

◆ operator++() [12/30]

EBoundAlgorithm ROL::operator++ ( EBoundAlgorithm type,
int   
)
inline

Definition at line 309 of file ROL_Types.hpp.

◆ operator--() [11/30]

EBoundAlgorithm& ROL::operator-- ( EBoundAlgorithm type)
inline

Definition at line 315 of file ROL_Types.hpp.

◆ operator--() [12/30]

EBoundAlgorithm ROL::operator-- ( EBoundAlgorithm type,
int   
)
inline

Definition at line 319 of file ROL_Types.hpp.

◆ StringToEBoundAlgorithm()

EBoundAlgorithm ROL::StringToEBoundAlgorithm ( std::string  s)
inline

◆ EDescentToString()

std::string ROL::EDescentToString ( EDescent  tr)
inline

◆ isValidDescent()

int ROL::isValidDescent ( EDescent  d)
inline

Verifies validity of a Secant enum.

Parameters
tr[in] - enum of the Secant
Returns
1 if the argument is a valid Secant; 0 otherwise.

Definition at line 373 of file ROL_Types.hpp.

References DESCENT_NEWTON, DESCENT_NEWTONKRYLOV, DESCENT_NONLINEARCG, DESCENT_SECANT, and DESCENT_STEEPEST.

◆ operator++() [13/30]

EDescent& ROL::operator++ ( EDescent type)
inline

Definition at line 382 of file ROL_Types.hpp.

◆ operator++() [14/30]

EDescent ROL::operator++ ( EDescent type,
int   
)
inline

Definition at line 386 of file ROL_Types.hpp.

◆ operator--() [13/30]

EDescent& ROL::operator-- ( EDescent type)
inline

Definition at line 392 of file ROL_Types.hpp.

◆ operator--() [14/30]

EDescent ROL::operator-- ( EDescent type,
int   
)
inline

Definition at line 396 of file ROL_Types.hpp.

◆ StringToEDescent()

EDescent ROL::StringToEDescent ( std::string  s)
inline

◆ ESecantToString()

std::string ROL::ESecantToString ( ESecant  tr)
inline

◆ isValidSecant()

int ROL::isValidSecant ( ESecant  s)
inline

Verifies validity of a Secant enum.

Parameters
tr[in] - enum of the Secant
Returns
1 if the argument is a valid Secant; 0 otherwise.

Definition at line 448 of file ROL_Types.hpp.

References SECANT_BARZILAIBORWEIN, SECANT_LBFGS, SECANT_LDFP, SECANT_LSR1, and SECANT_USERDEFINED.

◆ operator++() [15/30]

ESecant& ROL::operator++ ( ESecant type)
inline

Definition at line 457 of file ROL_Types.hpp.

◆ operator++() [16/30]

ESecant ROL::operator++ ( ESecant type,
int   
)
inline

Definition at line 461 of file ROL_Types.hpp.

◆ operator--() [15/30]

ESecant& ROL::operator-- ( ESecant type)
inline

Definition at line 467 of file ROL_Types.hpp.

◆ operator--() [16/30]

ESecant ROL::operator-- ( ESecant type,
int   
)
inline

Definition at line 471 of file ROL_Types.hpp.

◆ StringToESecant()

ESecant ROL::StringToESecant ( std::string  s)
inline

◆ EKrylovToString()

std::string ROL::EKrylovToString ( EKrylov  tr)
inline

◆ isValidKrylov()

int ROL::isValidKrylov ( EKrylov  d)
inline

Verifies validity of a Secant enum.

Parameters
tr[in] - enum of the Secant
Returns
1 if the argument is a valid Secant; 0 otherwise.

Definition at line 519 of file ROL_Types.hpp.

References KRYLOV_CG, KRYLOV_CR, KRYLOV_GMRES, and KRYLOV_USERDEFINED.

◆ operator++() [17/30]

EKrylov& ROL::operator++ ( EKrylov type)
inline

Definition at line 526 of file ROL_Types.hpp.

◆ operator++() [18/30]

EKrylov ROL::operator++ ( EKrylov type,
int   
)
inline

Definition at line 530 of file ROL_Types.hpp.

◆ operator--() [17/30]

EKrylov& ROL::operator-- ( EKrylov type)
inline

Definition at line 536 of file ROL_Types.hpp.

◆ operator--() [18/30]

EKrylov ROL::operator-- ( EKrylov type,
int   
)
inline

Definition at line 540 of file ROL_Types.hpp.

◆ StringToEKrylov()

EKrylov ROL::StringToEKrylov ( std::string  s)
inline

◆ ENonlinearCGToString()

std::string ROL::ENonlinearCGToString ( ENonlinearCG  tr)
inline

◆ isValidNonlinearCG()

int ROL::isValidNonlinearCG ( ENonlinearCG  s)
inline

Verifies validity of a NonlinearCG enum.

Parameters
tr[in] - enum of the NonlinearCG
Returns
1 if the argument is a valid NonlinearCG; 0 otherwise.

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.

◆ operator++() [19/30]

ENonlinearCG& ROL::operator++ ( ENonlinearCG type)
inline

Definition at line 621 of file ROL_Types.hpp.

◆ operator++() [20/30]

ENonlinearCG ROL::operator++ ( ENonlinearCG type,
int   
)
inline

Definition at line 625 of file ROL_Types.hpp.

◆ operator--() [19/30]

ENonlinearCG& ROL::operator-- ( ENonlinearCG type)
inline

Definition at line 631 of file ROL_Types.hpp.

◆ operator--() [20/30]

ENonlinearCG ROL::operator-- ( ENonlinearCG type,
int   
)
inline

Definition at line 635 of file ROL_Types.hpp.

◆ StringToENonlinearCG()

ENonlinearCG ROL::StringToENonlinearCG ( std::string  s)
inline

◆ ELineSearchToString()

std::string ROL::ELineSearchToString ( ELineSearch  ls)
inline

◆ isValidLineSearch()

int ROL::isValidLineSearch ( ELineSearch  ls)
inline

Verifies validity of a LineSearch enum.

Parameters
ls[in] - enum of the linesearch
Returns
1 if the argument is a valid linesearch; 0 otherwise.

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.

◆ operator++() [21/30]

ELineSearch& ROL::operator++ ( ELineSearch type)
inline

Definition at line 707 of file ROL_Types.hpp.

◆ operator++() [22/30]

ELineSearch ROL::operator++ ( ELineSearch type,
int   
)
inline

Definition at line 711 of file ROL_Types.hpp.

◆ operator--() [21/30]

ELineSearch& ROL::operator-- ( ELineSearch type)
inline

Definition at line 717 of file ROL_Types.hpp.

◆ operator--() [22/30]

ELineSearch ROL::operator-- ( ELineSearch type,
int   
)
inline

Definition at line 721 of file ROL_Types.hpp.

◆ StringToELineSearch()

ELineSearch ROL::StringToELineSearch ( std::string  s)
inline

◆ ECurvatureConditionToString()

std::string ROL::ECurvatureConditionToString ( ECurvatureCondition  ls)
inline

◆ isValidCurvatureCondition()

int ROL::isValidCurvatureCondition ( ECurvatureCondition  ls)
inline

Verifies validity of a CurvatureCondition enum.

Parameters
ls[in] - enum of the Curvature Conditions
Returns
1 if the argument is a valid curvature condition; 0 otherwise.

Definition at line 774 of file ROL_Types.hpp.

References CURVATURECONDITION_APPROXIMATEWOLFE, CURVATURECONDITION_GENERALIZEDWOLFE, CURVATURECONDITION_GOLDSTEIN, CURVATURECONDITION_NULL, CURVATURECONDITION_STRONGWOLFE, and CURVATURECONDITION_WOLFE.

◆ operator++() [23/30]

ECurvatureCondition& ROL::operator++ ( ECurvatureCondition type)
inline

Definition at line 784 of file ROL_Types.hpp.

◆ operator++() [24/30]

ECurvatureCondition ROL::operator++ ( ECurvatureCondition type,
int   
)
inline

Definition at line 788 of file ROL_Types.hpp.

◆ operator--() [23/30]

ECurvatureCondition& ROL::operator-- ( ECurvatureCondition type)
inline

Definition at line 794 of file ROL_Types.hpp.

◆ operator--() [24/30]

ECurvatureCondition ROL::operator-- ( ECurvatureCondition type,
int   
)
inline

Definition at line 798 of file ROL_Types.hpp.

◆ StringToECurvatureCondition()

ECurvatureCondition ROL::StringToECurvatureCondition ( std::string  s)
inline

◆ ECGFlagToString()

std::string ROL::ECGFlagToString ( ECGFlag  cgf)
inline

◆ ETestObjectivesToString()

std::string ROL::ETestObjectivesToString ( ETestObjectives  to)
inline

◆ isValidTestObjectives()

int ROL::isValidTestObjectives ( ETestObjectives  to)
inline

Verifies validity of a TestObjectives enum.

Parameters
ls[in] - enum of the TestObjectives
Returns
1 if the argument is a valid TestObjectives; 0 otherwise.

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.

◆ operator++() [25/30]

ETestObjectives& ROL::operator++ ( ETestObjectives type)
inline

Definition at line 912 of file ROL_Types.hpp.

◆ operator++() [26/30]

ETestObjectives ROL::operator++ ( ETestObjectives type,
int   
)
inline

Definition at line 916 of file ROL_Types.hpp.

◆ operator--() [25/30]

ETestObjectives& ROL::operator-- ( ETestObjectives type)
inline

Definition at line 922 of file ROL_Types.hpp.

◆ operator--() [26/30]

ETestObjectives ROL::operator-- ( ETestObjectives type,
int   
)
inline

Definition at line 926 of file ROL_Types.hpp.

◆ StringToETestObjectives()

ETestObjectives ROL::StringToETestObjectives ( std::string  s)
inline

◆ ETestOptProblemToString()

std::string ROL::ETestOptProblemToString ( ETestOptProblem  to)
inline

◆ isValidTestOptProblem()

int ROL::isValidTestOptProblem ( ETestOptProblem  to)
inline

Verifies validity of a TestOptProblem enum.

Parameters
ls[in] - enum of the TestOptProblem
Returns
1 if the argument is a valid TestOptProblem; 0 otherwise.

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.

◆ operator++() [27/30]

ETestOptProblem& ROL::operator++ ( ETestOptProblem type)
inline

Definition at line 1000 of file ROL_Types.hpp.

◆ operator++() [28/30]

ETestOptProblem ROL::operator++ ( ETestOptProblem type,
int   
)
inline

Definition at line 1004 of file ROL_Types.hpp.

◆ operator--() [27/30]

ETestOptProblem& ROL::operator-- ( ETestOptProblem type)
inline

Definition at line 1010 of file ROL_Types.hpp.

◆ operator--() [28/30]

ETestOptProblem ROL::operator-- ( ETestOptProblem type,
int   
)
inline

Definition at line 1014 of file ROL_Types.hpp.

◆ StringToETestOptProblem()

ETestOptProblem ROL::StringToETestOptProblem ( std::string  s)
inline

◆ EConstraintToString()

std::string ROL::EConstraintToString ( EConstraint  c)
inline

Definition at line 1043 of file ROL_Types.hpp.

References CONSTRAINT_EQUALITY, CONSTRAINT_INEQUALITY, and CONSTRAINT_LAST.

Referenced by StringToEConstraint().

◆ isValidConstraint()

int ROL::isValidConstraint ( EConstraint  c)
inline

Verifies validity of a Secant enum.

Parameters
c[in] - enum of the Secant
Returns
1 if the argument is a valid Secant; 0 otherwise.

Definition at line 1059 of file ROL_Types.hpp.

References CONSTRAINT_EQUALITY, and CONSTRAINT_INEQUALITY.

◆ operator++() [29/30]

EConstraint& ROL::operator++ ( EConstraint type)
inline

Definition at line 1064 of file ROL_Types.hpp.

◆ operator++() [30/30]

EConstraint ROL::operator++ ( EConstraint type,
int   
)
inline

Definition at line 1068 of file ROL_Types.hpp.

◆ operator--() [29/30]

EConstraint& ROL::operator-- ( EConstraint type)
inline

Definition at line 1074 of file ROL_Types.hpp.

◆ operator--() [30/30]

EConstraint ROL::operator-- ( EConstraint type,
int   
)
inline

Definition at line 1078 of file ROL_Types.hpp.

◆ StringToEConstraint()

EConstraint ROL::StringToEConstraint ( std::string  s)
inline

◆ rol_cast()

template<class Element , class Real >
Real ROL::rol_cast ( const Element &  val)

Definition at line 1140 of file ROL_Types.hpp.

References ROL::TypeCaster< Real, Element >::ElementToReal().

◆ addJSONBlockToPL()

void ROL::addJSONBlockToPL ( const Json::Value &  block,
Teuchos::ParameterList &  parlist 
)

Iterate over a block and insert key-value pairs into the Teuchos::ParameterList.

Parameters
[in]blockis 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().

◆ addJSONPairToPL()

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.

Parameters
[in]blockis a block from a JSON object
[in]keyis 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().

◆ JSON_Parameters()

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.

Parameters
[in]blockis 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().

◆ stepFactory()

template<class Real >
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.

Parameters
[in]parlistis 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().