ROL
Classes | Namespaces | Macros | Typedefs | Functions | Variables
ROL_Objective_SerialSimOpt.hpp File Reference
#include "ROL_Objective_TimeSimOpt.hpp"

Go to the source code of this file.

Classes

class  ROL::Objective_SerialSimOpt< Real >
 

Namespaces

 ROL
 

Macros

#define ROL_OBJECTIVE_SERIALSIMOPT_HPP
 

Typedefs

using V = Vector< Real >
 
using PV = PartitionedVector< Real >
 
using Obj = Objective_TimeSimOpt< Real >
 
using size_type = typename PV< Real >::size_type
 

Functions

template<typename Real >
ROL::Objective_SerialSimOpt
Objective_SimOpt 
ROL::value (const V &u, const V &z, Real &tol) override
 
PVpartition (V &x) const
 
const PVpartition (const V &x) const
 
virtual void ROL::gradient_1 (V &g, const V &u, const V &z, Real &tol) override
 
virtual void ROL::gradient_2 (V &g, const V &u, const V &z, Real &tol) override
 
virtual void ROL::hessVec_11 (V &hv, const V &v, const V &u, const V &z, Real &tol) override
 
virtual void ROL::hessVec_12 (V &hv, const V &v, const V &u, const V &z, Real &tol) override
 
virtual void ROL::hessVec_21 (V &hv, const V &v, const V &u, const V &z, Real &tol) override
 
virtual void ROL::hessVec_22 (V &hv, const V &v, const V &u, const V &z, Real &tol) override
 

Variables

const Ptr< Objobj_
 
const Ptr< Vui_
 
VectorWorkspace< Real > workspace_
 
Objective_SerialSimOpt(const
Ptr< Obj > &obj, const V &ui)
z0_ 
zero ()
 

Macro Definition Documentation

#define ROL_OBJECTIVE_SERIALSIMOPT_HPP

Definition at line 47 of file ROL_Objective_SerialSimOpt.hpp.

Typedef Documentation

using V = Vector<Real>

Definition at line 120 of file ROL_Objective_SerialSimOpt.hpp.

using PV = PartitionedVector<Real>

Definition at line 121 of file ROL_Objective_SerialSimOpt.hpp.

using Obj = Objective_TimeSimOpt<Real>

Definition at line 122 of file ROL_Objective_SerialSimOpt.hpp.

using size_type = typename PV<Real>::size_type

Definition at line 124 of file ROL_Objective_SerialSimOpt.hpp.

Function Documentation

PV& value::partition ( V x) const
protected

Definition at line 136 of file ROL_Objective_SerialSimOpt.hpp.

const PV& value::partition ( const V x) const
protected

Definition at line 138 of file ROL_Objective_SerialSimOpt.hpp.

References obj_.

Variable Documentation

const Ptr<Obj> obj_

Definition at line 128 of file ROL_Objective_SerialSimOpt.hpp.

Referenced by ROL::PrimalDualInteriorPointBlock11< Real >::apply(), ROL::ConstraintFromObjective< Real >::applyAdjointHessian(), ROL::ConstraintFromObjective< Real >::applyAdjointJacobian(), ROL::ConstraintFromObjective< Real >::applyJacobian(), ROL::SlacklessObjective< Real >::dirDeriv(), ROL::Problem< Real >::finalize(), ROL::SlacklessObjective< Real >::getObjective(), ROL::ConstraintFromObjective< Real >::getObjective(), ROL::Problem< Real >::getObjective(), ROL::RiskLessObjective< Real >::gradient(), ROL::ScaledObjective< Real >::gradient(), ROL::MeanValueObjective< Real >::gradient(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::SlacklessObjective< Real >::gradient(), ROL::AffineTransformObjective< Real >::gradient(), ROL::FletcherObjectiveE< Real >::gradient(), ROL::Reduced_Objective_SimOpt< Real >::gradient(), ROL::gradient_1(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_un(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_un_un(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_un_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_un_z(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_uo_un(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_uo_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_uo_z(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_z(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_z_un(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_z_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::gradient_z_z(), ROL::RiskLessObjective< Real >::hessVec(), ROL::ScaledObjective< Real >::hessVec(), ROL::MeanValueObjective< Real >::hessVec(), ROL::LinearCombinationObjective< Real >::hessVec(), ROL::SlacklessObjective< Real >::hessVec(), ROL::AffineTransformObjective< Real >::hessVec(), ROL::FletcherObjectiveE< Real >::hessVec(), ROL::Reduced_Objective_SimOpt< Real >::hessVec(), ROL::hessVec_21(), ROL::hessVec_22(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_un_un(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_un_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_un_z(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_uo_un(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_uo_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_uo_z(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_z_un(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_z_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::hessVec_z_z(), ROL::ScaledObjective< Real >::invHessVec(), ROL::SlacklessObjective< Real >::invHessVec(), ROL::FletcherObjectiveBase< Real >::objGrad(), ROL::FletcherObjectiveBase< Real >::objValue(), partition(), ROL::RiskLessObjective< Real >::precond(), ROL::MeanValueObjective< Real >::precond(), ROL::ScaledObjective< Real >::precond(), ROL::SlacklessObjective< Real >::precond(), ROL::ScaledObjective< Real >::setParameter(), ROL::RiskLessObjective< Real >::setParameter(), ROL::LinearCombinationObjective< Real >::setParameter(), ROL::ConstraintFromObjective< Real >::setParameter(), ROL::SlacklessObjective< Real >::setParameter(), ROL::AffineTransformObjective< Real >::setParameter(), ROL::Reduced_Objective_SimOpt< Real >::setParameter(), ROL::Reduced_Objective_SimOpt< Real >::solve_adjoint_equation(), ROL::Reduced_Objective_SimOpt< Real >::solve_adjoint_sensitivity(), ROL::Reduced_Objective_SimOpt< Real >::solve_state_equation(), ROL::RiskLessObjective< Real >::update(), ROL::ScaledObjective< Real >::update(), ROL::MeanValueObjective< Real >::update(), ROL::LinearCombinationObjective< Real >::update(), ROL::SlacklessObjective< Real >::update(), ROL::ConstraintFromObjective< Real >::update(), ROL::AffineTransformObjective< Real >::update(), ROL::PrimalDualInteriorPointBlock11< Real >::update(), ROL::FletcherObjectiveBase< Real >::update(), ROL::details::DynamicObjective_CheckInterface< Real >::update_un(), ROL::details::DynamicObjective_CheckInterface< Real >::update_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::update_z(), ROL::RiskLessObjective< Real >::value(), ROL::ScaledObjective< Real >::value(), ROL::MeanValueObjective< Real >::value(), ROL::LinearCombinationObjective< Real >::value(), ROL::SlacklessObjective< Real >::value(), ROL::ConstraintFromObjective< Real >::value(), ROL::AffineTransformObjective< Real >::value(), ROL::value(), ROL::Reduced_Objective_SimOpt< Real >::value(), ROL::details::DynamicObjective_CheckInterface< Real >::value_un(), ROL::details::DynamicObjective_CheckInterface< Real >::value_uo(), and ROL::details::DynamicObjective_CheckInterface< Real >::value_z().

const Ptr<V> ui_
VectorWorkspace<Real> workspace_
Objective_SerialSimOpt ( const Ptr<Obj>& obj, const V& ui ) z0_ zero()

Definition at line 145 of file ROL_Objective_SerialSimOpt.hpp.

Referenced by ROL::TypeE::CompositeStepAlgorithm< Real >::accept(), ROL::CompositeStep< Real >::accept(), ROL::Bundle_U< Real >::add(), ROL::Bundle< Real >::add(), ROL::Bundle_U< Real >::aggregate(), ROL::Bundle< Real >::aggregate(), ROL::TRUtils::analyzeRatio(), ROL::LinMore< Real >::LowerBreakPoint::apply(), ROL::BinaryConstraint< Real >::BoundsCheck::apply(), ROL::LinMore< Real >::UpperBreakPoint::apply(), ROL::KelleySachsModel< Real >::PruneBinding::apply(), ROL::InteriorPointObjective< Real >::ModifiedLogarithm::apply(), ROL::KelleySachsModel< Real >::PruneNonbinding::apply(), ROL::InteriorPointObjective< Real >::ModifiedReciprocal::apply(), ROL::InteriorPointObjective< Real >::ModifiedDivide::apply(), ROL::Bounds< Real >::SetZeroEntry::apply(), ROL::InteriorPointObjective< Real >::Mask::apply(), ROL::BoundFletcher< Real >::FormQ::apply(), ROL::BoundFletcher< Real >::FormDQ::apply(), ROL::ZOO::InequalityConstraint_HS32< Real >::applyAdjointHessian(), ROL::ReducedLinearConstraint< Real >::applyAdjointJacobian(), ROL::LinMoreModel< Real >::applyFreeHessian(), ROL::TypeB::LSecantBAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::LinMoreAlgorithm< Real >::applyFreeHessian(), ROL::LinMoreModel< Real >::applyFreePrecond(), ROL::TypeB::LSecantBAlgorithm< Real >::applyFreePrecond(), ROL::TypeB::LinMoreAlgorithm< Real >::applyFreePrecond(), ROL::AugmentedSystemPrecOperator< Real >::applyInverse(), ROL::Fletcher< Real >::AugSystemPrecond::applyInverse(), ROL::BoundFletcher< Real >::AugSystemPrecond::applyInverse(), ROL::ReducedLinearConstraint< Real >::applyJacobian(), ROL::Bundle_U_AS< Real >::applyPreconditioner(), ROL::Bundle_AS< Real >::applyPreconditioner(), ROL::Bundle_U_AS< Real >::applyPreconditioner_Jacobi(), ROL::Bundle_AS< Real >::applyPreconditioner_Jacobi(), ROL::StdBoundConstraint< Real >::applyScalingFunctionJacobian(), ROL::Bounds< Real >::buildScalingFunction(), ROL::Bundle< Real >::Bundle(), ROL::Bundle_U< Real >::Bundle_U(), ROL::TypeU::BundleAlgorithm< Real >::BundleAlgorithm(), ROL::BundleStep< Real >::BundleStep(), ROL::ExpectationQuad< Real >::check(), ROL::TruncatedMeanQuadrangle< Real >::check(), ROL::SmoothedWorstCaseQuadrangle< Real >::check(), ROL::LogQuantileQuadrangle< Real >::check(), ROL::MoreauYosidaCVaR< Real >::check(), ROL::QuantileQuadrangle< Real >::check(), ROL::GenMoreauYosidaCVaR< Real >::check(), ROL::TruncatedMeanQuadrangle< Real >::checkInputs(), ROL::QuantileRadius< Real >::checkInputs(), ROL::EntropicRisk< Real >::checkInputs(), ROL::MeanSemiDeviationFromTarget< Real >::checkInputs(), ROL::PD_MeanSemiDeviation< Real >::checkInputs(), ROL::PD_MeanSemiDeviationFromTarget< Real >::checkInputs(), ROL::PD_CVaR< Real >::checkInputs(), ROL::PD_HMCR2< Real >::checkInputs(), ROL::MeanVarianceQuadrangle< Real >::checkInputs(), ROL::CVaR< Real >::checkInputs(), ROL::ConvexCombinationRiskMeasure< Real >::checkInputs(), ROL::MeanVarianceFromTarget< Real >::checkInputs(), ROL::LogExponentialQuadrangle< Real >::checkInputs(), ROL::KLDivergence< Real >::checkInputs(), ROL::LogQuantileQuadrangle< Real >::checkInputs(), ROL::FDivergence< Real >::checkInputs(), ROL::MeanSemiDeviation< Real >::checkInputs(), ROL::HMCR< Real >::checkInputs(), ROL::SmoothedWorstCaseQuadrangle< Real >::checkInputs(), ROL::MeanVariance< Real >::checkInputs(), ROL::MixedCVaR< Real >::checkInputs(), ROL::MeanDeviationFromTarget< Real >::checkInputs(), ROL::QuantileQuadrangle< Real >::checkInputs(), ROL::MoreauYosidaCVaR< Real >::checkInputs(), ROL::GenMoreauYosidaCVaR< Real >::checkInputs(), ROL::MeanDeviation< Real >::checkInputs(), ROL::MeanDeviation< Real >::clear(), ROL::TypeE::CompositeStepAlgorithm< Real >::CompositeStepAlgorithm(), ROL::BundleStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::ColemanLiModel< Real >::computeAlpha(), ROL::Sketch< Real >::computeC(), ROL::Bundle_U_AS< Real >::computeCriticality(), ROL::Bundle_AS< Real >::computeCriticality(), ROL::PD_RandVarFunctional< Real >::computeDual(), ROL::PD_HMCR2< Real >::computeDual(), ROL::MonteCarloGenerator< Real >::computeError(), ROL::Bundle_U_AS< Real >::computeLagMult(), ROL::Bundle_AS< Real >::computeLagMult(), ROL::TypeE::CompositeStepAlgorithm< Real >::computeQuasinormalStep(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::Bundle_U_AS< Real >::computeStepSize(), ROL::Bundle_AS< Real >::computeStepSize(), ROL::ColemanLiModel< Real >::constructC(), ROL::ColemanLiModel< Real >::constructInverseD(), ROL::TypeP::TrustRegionAlgorithm< Real >::dbls(), ROL::LinMore< Real >::dbreakpt(), ROL::Bundle_U_TT< Real >::deleteSubgradFromBase(), ROL::Bundle_TT< Real >::deleteSubgradFromBase(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dproj(), ROL::TypeP::TrustRegionAlgorithm< Real >::dprox(), ROL::TypeB::LinMoreAlgorithm< Real >::dprsrch(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrqsol(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrqsol(), ROL::LinMore< Real >::dtrqsol(), ROL::Gaussian< Real >::erfi(), ROL::TruncatedMeanQuadrangle< Real >::error(), ROL::ExpectationQuad< Real >::error(), ROL::SmoothedWorstCaseQuadrangle< Real >::error(), ROL::LogQuantileQuadrangle< Real >::error(), ROL::MoreauYosidaCVaR< Real >::error(), ROL::GenMoreauYosidaCVaR< Real >::error(), ROL::TruncatedGaussian< Real >::evaluateCDF(), ROL::TruncatedGaussian< Real >::evaluatePDF(), ROL::Chi2Divergence< Real >::Fdual(), ROL::FletcherStep< Real >::FletcherStep(), ROL::Chi2Divergence< Real >::Fprimal(), ROL::BPOE< Real >::getGradient(), ROL::HMCR< Real >::getGradient(), ROL::MeanVariance< Real >::getGradient(), ROL::MeanDeviationFromTarget< Real >::getGradient(), ROL::MeanDeviation< Real >::getGradient(), ROL::BPOE< Real >::getHessVec(), ROL::HMCR< Real >::getHessVec(), ROL::MeanVariance< Real >::getHessVec(), ROL::MeanDeviationFromTarget< Real >::getHessVec(), ROL::MeanDeviation< Real >::getHessVec(), ROL::ZOO::getParaboloidCircle< Real, XPrim, XDual, CPrim, CDual >::getSolution(), ROL::details::MINRES< Real >::givens(), ROL::GMRES< Real >::GMRES(), ROL::Objective< Real >::gradient(), ROL::ObjectiveFromBoundConstraint< Real >::gradient(), ROL::Fletcher< Real >::gradient(), ROL::BoundFletcher< Real >::gradient(), ROL::Objective< Real >::hessVec(), ROL::Fletcher< Real >::hessVec(), ROL::BoundFletcher< Real >::hessVec(), ROL::ZOO::Objective_CylinderHead< Real >::horsepower(), ROL::MonteCarloGenerator< Real >::ierf(), ROL::TypeB::SpectralGradientAlgorithm< Real >::initialize(), ROL::TypeP::SpectralGradientAlgorithm< Real >::initialize(), ROL::CoherentEntropicRisk< Real >::initialize(), ROL::Step< Real >::initialize(), ROL::Bundle_U< Real >::initialize(), ROL::TypeU::TrustRegionAlgorithm< Real >::initialize(), ROL::KLDivergence< Real >::initialize(), ROL::InteriorPointObjective< Real >::initialize(), ROL::Bundle< Real >::initialize(), ROL::HMCR< Real >::initialize(), ROL::MeanDeviationFromTarget< Real >::initialize(), ROL::RandVarFunctional< Real >::initialize(), ROL::PrimalDualActiveSetStep< Real >::initialize(), ROL::TrustRegionStep< Real >::initialize(), ROL::Bundle_U_AS< Real >::initializeDualSolver(), ROL::Bundle_AS< Real >::initializeDualSolver(), ROL::QuantileRadius< Real >::initializeQR(), ROL::TRUtils::initialRadius(), ROL::InteriorPointPenalty< Real >::InteriorPointPenalty(), ROL::Gaussian< Real >::invertCDF(), ROL::LineSearch< Real >::LineSearch(), ROL::LineSearch_U< Real >::LineSearch_U(), ROL::Sketch< Real >::lowRankApprox(), main(), ROL::Sketch< Real >::mgs2(), ROL::MomentObjective< Real >::momentHessVec(), ROL::PlusFunction< Real >::PlusFunction(), ROL::PD_RandVarFunctional< Real >::ppf(), ROL::PH_bPOEObjective< Real >::pplus(), ROL::ProbabilityInfo(), ROL::Bundle_U_AS< Real >::project(), ROL::Bundle_AS< Real >::project(), ROL::BrentsProjection< Real >::project_df(), ROL::RiddersProjection< Real >::project_df(), ROL::DaiFletcherProjection< Real >::project_df(), ROL::SemismoothNewtonProjection< Real >::project_ssn(), ROL::Bundle_U_AS< Real >::projectedCG(), ROL::Bundle_AS< Real >::projectedCG(), ROL::Sketch< Real >::reconstruct(), ROL::LinMore< Real >::PositiveMin::reduce(), ROL::LinMore< Real >::PositiveMax::reduce(), ROL::TruncatedMeanQuadrangle< Real >::regret(), ROL::MeanVarianceQuadrangle< Real >::regret(), ROL::LogExponentialQuadrangle< Real >::regret(), ROL::SmoothedWorstCaseQuadrangle< Real >::regret(), ROL::LogQuantileQuadrangle< Real >::regret(), ROL::MoreauYosidaCVaR< Real >::regret(), ROL::QuantileQuadrangle< Real >::regret(), ROL::GenMoreauYosidaCVaR< Real >::regret(), ROL::Bundle_U< Real >::remove(), ROL::Bundle< Real >::remove(), ROL::RiskMeasure< Real >::reset(), ROL::Sketch< Real >::reset(), ROL::Bundle_U< Real >::resetDualVariables(), ROL::Bundle< Real >::resetDualVariables(), ROL::RiskMeasureInfo(), ROL::ConjugateGradients< Real >::run(), ROL::GoldenSection< Real >::run(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::PathBasedTargetLevel_U< Real >::run(), ROL::PathBasedTargetLevel< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::TypeU::BundleAlgorithm< Real >::run(), ROL::TypeB::LSecantBAlgorithm< Real >::run(), ROL::TypeU::TrustRegionAlgorithm< Real >::run(), ROL::GMRES< Real >::run(), ROL::TypeB::ColemanLiAlgorithm< Real >::run(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::run(), ROL::TypeB::LinMoreAlgorithm< Real >::run(), ROL::LinMore< Real >::run(), ROL::TypeP::TrustRegionAlgorithm< Real >::run(), ROL::ProgressiveHedging< Real >::run(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::run(), ROL::Brents< Real >::run_brents(), ROL::MonteCarloGenerator< Real >::sample(), ROL::ScalarMinimizationLineSearch< Real >::ScalarMinimizationLineSearch(), ROL::ScalarMinimizationLineSearch_U< Real >::ScalarMinimizationLineSearch_U(), ROL::StdBoundConstraint< Real >::sgn(), ROL::StdObjective< Real >::sgn(), ROL::Bundle_U_TT< Real >::sgn(), ROL::Bundle_TT< Real >::sgn(), ROL::CauchyPoint_U< Real >::solve(), ROL::DoubleDogLeg_U< Real >::solve(), ROL::DogLeg_U< Real >::solve(), ROL::TruncatedCG_U< Real >::solve(), ROL::SPGTrustRegion_U< Real >::solve(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::Bundle_U_AS< Real >::solveDual_arbitrary(), ROL::Bundle_AS< Real >::solveDual_arbitrary(), ROL::Bundle_U< Real >::solveDual_dim2(), ROL::Bundle< Real >::solveDual_dim2(), ROL::Bundle_U_TT< Real >::solveDual_TT(), ROL::Bundle_TT< Real >::solveDual_TT(), ROL::Bundle_U_AS< Real >::solveEQPsubproblem(), ROL::Bundle_AS< Real >::solveEQPsubproblem(), ROL::TypeE::CompositeStepAlgorithm< Real >::solveTangentialSubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::Bundle_U_TT< Real >::swapRowsL(), ROL::Bundle_TT< Real >::swapRowsL(), ROL::Brents< Real >::test_brents(), ROL::Sketch< Real >::testP(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::TypeB::KelleySachsAlgorithm< Real >::trqsol(), ROL::TruncatedGaussian< Real >::TruncatedGaussian(), ROL::ZOO::Constraint_CylinderHead< Real >::twall(), ROL::Bundle_U< Real >::update(), ROL::TrustRegion< Real >::update(), ROL::ReducedDynamicObjective< Real >::update(), ROL::Bundle< Real >::update(), ROL::CompositeStep< Real >::update(), ROL::BPOE< Real >::updateGradient(), ROL::PD_BPOE< Real >::updateGradient(), ROL::PD_CVaR< Real >::updateGradient(), ROL::PD_HMCR2< Real >::updateGradient(), ROL::PD_MeanSemiDeviationFromTarget< Real >::updateHessVec(), ROL::BPOE< Real >::updateHessVec(), ROL::PD_BPOE< Real >::updateHessVec(), ROL::PD_CVaR< Real >::updateHessVec(), ROL::PD_HMCR2< Real >::updateHessVec(), ROL::TypeE::CompositeStepAlgorithm< Real >::updateRadius(), ROL::BPOE< Real >::updateValue(), ROL::PD_HMCR2< Real >::updateValue(), ROL::BallIndicatorObjective< Real >::value(), ROL::ReducedLinearConstraint< Real >::value(), ROL::TypeBIndicatorObjective< Real >::value(), ROL::ObjectiveFromBoundConstraint< Real >::value(), ROL::Fletcher< Real >::value(), ROL::InteriorPointObjective< Real >::value(), ROL::BoundFletcher< Real >::value(), ROL::ZOO::Objective_CylinderHead< Real >::warranty(), and ROL::ZOO::Constraint_CylinderHead< Real >::warranty().