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 138 of file ROL_Objective_SerialSimOpt.hpp.

using PV = PartitionedVector<Real>

Definition at line 139 of file ROL_Objective_SerialSimOpt.hpp.

using Obj = Objective_TimeSimOpt<Real>

Definition at line 140 of file ROL_Objective_SerialSimOpt.hpp.

using size_type = typename PV<Real>::size_type

Definition at line 142 of file ROL_Objective_SerialSimOpt.hpp.

Function Documentation

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

Definition at line 154 of file ROL_Objective_SerialSimOpt.hpp.

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

Definition at line 156 of file ROL_Objective_SerialSimOpt.hpp.

Variable Documentation

const Ptr<Obj> obj_

Definition at line 146 of file ROL_Objective_SerialSimOpt.hpp.

Referenced by ROL::PrimalDualInteriorPointBlock11< Real >::apply(), ROL::gradient_1(), ROL::gradient_2(), 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::hessVec_11(), 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::PrimalDualInteriorPointBlock11< Real >::update(), ROL::details::DynamicObjective_CheckInterface< Real >::update_un(), ROL::details::DynamicObjective_CheckInterface< Real >::update_uo(), ROL::details::DynamicObjective_CheckInterface< Real >::update_z(), ROL::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 163 of file ROL_Objective_SerialSimOpt.hpp.

Referenced by ROL::CompositeStep< Real >::accept(), ROL::Bundle< Real >::add(), ROL::Bundle< Real >::aggregate(), ROL::LinMore< Real >::LowerBreakPoint::apply(), ROL::LinMore< Real >::UpperBreakPoint::apply(), ROL::KelleySachsModel< Real >::PruneBinding::apply(), ROL::KelleySachsModel< Real >::PruneNonbinding::apply(), ROL::BoundFletcher< Real >::FormQ::apply(), ROL::BoundFletcher< Real >::FormDQ::apply(), ROL::lDFP< Real >::applyB(), ROL::LinMoreModel< Real >::applyFreeHessian(), ROL::LinMoreModel< Real >::applyFreePrecond(), ROL::lBFGS< Real >::applyH(), ROL::AugmentedSystemPrecOperator< Real >::applyInverse(), ROL::Fletcher< Real >::AugSystemPrecond::applyInverse(), ROL::BoundFletcher< Real >::AugSystemPrecond::applyInverse(), ROL::Bundle_AS< Real >::applyPreconditioner(), ROL::Bundle_AS< Real >::applyPreconditioner_Jacobi(), ROL::Bundle< Real >::Bundle(), ROL::BundleStep< Real >::BundleStep(), ROL::TruncatedMeanQuadrangle< Real >::check(), ROL::ExpectationQuad< 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::CVaR< Real >::checkInputs(), ROL::MeanVarianceQuadrangle< 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::BundleStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::ColemanLiModel< Real >::computeAlpha(), ROL::Sketch< Real >::computeC(), ROL::Bundle_AS< Real >::computeCriticality(), ROL::PD_RandVarFunctional< Real >::computeDual(), ROL::PD_HMCR2< Real >::computeDual(), ROL::MonteCarloGenerator< Real >::computeError(), ROL::Bundle_AS< Real >::computeLagMult(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::Bundle_AS< Real >::computeStepSize(), ROL::ColemanLiModel< Real >::constructC(), ROL::ColemanLiModel< Real >::constructInverseD(), ROL::LinMore< Real >::dbreakpt(), ROL::Bundle_TT< Real >::deleteSubgradFromBase(), ROL::Objective< Real >::dirDeriv(), ROL::LinMore< Real >::dtrpcg(), 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::CoherentEntropicRisk< Real >::initialize(), ROL::Step< Real >::initialize(), ROL::KLDivergence< 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_AS< Real >::initializeDualSolver(), ROL::QuantileRadius< Real >::initializeQR(), ROL::InteriorPointPenalty< Real >::InteriorPointPenalty(), ROL::Gaussian< Real >::invertCDF(), ROL::LineSearch< Real >::LineSearch(), ROL::Sketch< Real >::lowRankApprox(), main(), ROL::MomentObjective< Real >::momentHessVec(), ROL::PlusFunction< Real >::PlusFunction(), ROL::PD_RandVarFunctional< Real >::ppf(), ROL::PH_bPOEObjective< Real >::pplus(), ROL::ProbabilityInfo(), ROL::Bundle_AS< Real >::project(), ROL::Bundle_AS< Real >::projectedCG(), ROL::Sketch< Real >::reconstruct(), ROL::LinMore< Real >::PositiveMin::reduce(), ROL::LinMore< Real >::PositiveMax::reduce(), ROL::MonteCarloGenerator< Real >::refine(), 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< Real >::remove(), ROL::RiskMeasure< Real >::reset(), ROL::Sketch< Real >::reset(), ROL::Bundle< Real >::resetDualVariables(), ROL::RiskMeasureInfo(), ROL::ConjugateGradients< Real >::run(), ROL::GoldenSection< Real >::run(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::PathBasedTargetLevel< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::GMRES< Real >::run(), ROL::LinMore< Real >::run(), ROL::ProgressiveHedging< Real >::run(), ROL::Brents< Real >::run_brents(), ROL::MonteCarloGenerator< Real >::sample(), ROL::ScalarMinimizationLineSearch< Real >::ScalarMinimizationLineSearch(), ROL::StdObjective< Real >::sgn(), ROL::Bundle_TT< Real >::sgn(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::Bundle_AS< Real >::solveDual_arbitrary(), ROL::Bundle< Real >::solveDual_dim2(), ROL::Bundle_TT< Real >::solveDual_TT(), ROL::Bundle_AS< Real >::solveEQPsubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::Bundle_TT< Real >::swapRowsL(), ROL::Brents< Real >::test_brents(), ROL::Sketch< Real >::testP(), ROL::TruncatedGaussian< Real >::TruncatedGaussian(), ROL::ZOO::Constraint_CylinderHead< Real >::twall(), ROL::TrustRegion< Real >::update(), ROL::MonteCarloGenerator< 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::BPOE< Real >::updateValue(), ROL::PD_HMCR2< Real >::updateValue(), ROL::ObjectiveFromBoundConstraint< Real >::value(), ROL::Fletcher< Real >::value(), ROL::BoundFletcher< Real >::value(), ROL::ZOO::Objective_CylinderHead< Real >::warranty(), and ROL::ZOO::Constraint_CylinderHead< Real >::warranty().