ROL
|
Defines the linear algebra or vector space interface. More...
#include <ROL_Vector.hpp>
Public Member Functions | |
virtual | ~Vector () |
virtual void | plus (const Vector &x)=0 |
Compute \(y \leftarrow y + x\), where \(y = \mathtt{*this}\). More... | |
virtual void | scale (const Real alpha)=0 |
Compute \(y \leftarrow \alpha y\) where \(y = \mathtt{*this}\). More... | |
virtual Real | dot (const Vector &x) const =0 |
Compute \( \langle y,x \rangle \) where \(y = \mathtt{*this}\). More... | |
virtual Real | norm () const =0 |
Returns \( \| y \| \) where \(y = \mathtt{*this}\). More... | |
virtual ROL::Ptr< Vector > | clone () const =0 |
Clone to make a new (uninitialized) vector. More... | |
virtual void | axpy (const Real alpha, const Vector &x) |
Compute \(y \leftarrow \alpha x + y\) where \(y = \mathtt{*this}\). More... | |
virtual void | zero () |
Set to zero vector. More... | |
virtual ROL::Ptr< Vector > | basis (const int i) const |
Return i-th basis vector. More... | |
virtual int | dimension () const |
Return dimension of the vector space. More... | |
virtual void | set (const Vector &x) |
Set \(y \leftarrow x\) where \(y = \mathtt{*this}\). More... | |
virtual const Vector & | dual () const |
Return dual representation of \(\mathtt{*this}\), for example, the result of applying a Riesz map, or change of basis, or change of memory layout. More... | |
virtual Real | apply (const Vector< Real > &x) const |
Apply \(\mathtt{*this}\) to a dual vector. This is equivalent to the call \(\mathtt{this->dot(x.dual())}\). More... | |
virtual void | applyUnary (const Elementwise::UnaryFunction< Real > &f) |
virtual void | applyBinary (const Elementwise::BinaryFunction< Real > &f, const Vector &x) |
virtual Real | reduce (const Elementwise::ReductionOp< Real > &r) const |
virtual void | print (std::ostream &outStream) const |
virtual void | setScalar (const Real C) |
Set \(y \leftarrow C\) where \(C\in\mathbb{R}\). More... | |
virtual void | randomize (const Real l=0.0, const Real u=1.0) |
Set vector to be uniform random between [l,u]. More... | |
virtual std::vector< Real > | checkVector (const Vector< Real > &x, const Vector< Real > &y, const bool printToStream=true, std::ostream &outStream=std::cout) const |
Verify vector-space methods. More... | |
Defines the linear algebra or vector space interface.
The basic linear algebra interface, to be implemented by the user, includes:
The dot product can represent an inner product (in Hilbert space) or a duality pairing (in general Banach space).
There are additional virtual member functions that can be overloaded for computational efficiency.
Definition at line 46 of file ROL_Vector.hpp.
|
inlinevirtual |
Definition at line 53 of file ROL_Vector.hpp.
|
pure virtual |
Compute \(y \leftarrow y + x\), where \(y = \mathtt{*this}\).
[in] | x | is the vector to be added to \(\mathtt{*this}\). |
On return \(\mathtt{*this} = \mathtt{*this} + x\).
Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::RiskVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::SimulatedVector< Real >, OptStdVector< Real, Element >, ROL::StdArray< Real, array_size, pool_size >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, OptStdVector< Real, Element >, ROL::StdVector< Real >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::ElementwiseVector< Real >.
Referenced by ROL::TypeE::CompositeStepAlgorithm< Real >::accept(), ROL::CompositeStep< Real >::accept(), ROL::ReducedDynamicObjective< Real >::addAdjointSens(), ROL::ReducedDynamicObjective< Real >::addMixedHessLag(), ROL::ReducedDynamicObjective< Real >::advanceAdjoint(), ROL::LinearOperatorSum< Real >::apply(), ROL::ProjectedNewtonKrylovStep< Real >::HessianPNK::apply(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::HessianPNK::apply(), ROL::ChainRuleConstraint< Real >::applyAdjointHessian(), ROL::Reduced_Constraint_SimOpt< Real >::applyAdjointHessian(), ROL::CompositeConstraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::BoundToConstraint< Real >::applyAdjointJacobian(), ROL::Reduced_Constraint_SimOpt< Real >::applyAdjointJacobian(), ROL::TypeB::KelleySachsAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::KelleySachsAlgorithm< Real >::applyFreePrecond(), ROL::TypeB::ColemanLiAlgorithm< Real >::applyHessian(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::PrecondPNK::applyInverse(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::PrecondPDAS::applyInverse(), ROL::ProjectedNewtonKrylovStep< Real >::PrecondPNK::applyInverse(), ROL::ElasticLinearConstraint< Real >::applyJacobian(), ROL::Reduced_Constraint_SimOpt< Real >::applyJacobian(), ROL::Constraint_SimOpt< Real >::applyJacobian(), ROL::Bounds< Real >::applyScalingFunctionJacobian(), ROL::Vector< Real >::axpy(), ROL::Bounds< Real >::buildScalingFunction(), ROL::ProjectedNewtonStep< Real >::compute(), ROL::ProjectedSecantStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::TypeE::CompositeStepAlgorithm< Real >::computeLagrangeMultiplier(), ROL::CompositeStep< Real >::computeLagrangeMultiplier(), ROL::ReducedDynamicObjective< Real >::computeNewMixedHessLag(), ROL::ReducedDynamicObjective< Real >::computeNewStateHessLag(), ROL::ReducedDynamicObjective< Real >::computeOldMixedHessLag(), ROL::ReducedDynamicObjective< Real >::computeOldStateHessLag(), ROL::BoundConstraint< Real >::computeProjectedStep(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dprsrch(), ROL::LinMore< Real >::dprsrch(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::TypeB::LSecantBAlgorithm< Real >::dsrch(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::MeanVariance< Real >::getGradient(), ROL::PD_MeanSemiDeviation< Real >::getHessVec(), ROL::MeanVariance< Real >::getHessVec(), ROL::PQNObjective< Real >::gradient(), ROL::QuadraticObjective< Real >::gradient(), ROL::ConicApproximationModel< Real >::gradient(), ROL::TypeP::InexactNewtonAlgorithm< Real >::NewtonObj::gradient(), ROL::InteriorPoint::PenalizedObjective< Real >::gradient(), ROL::PH_Objective< Real >::gradient(), ROL::FletcherObjectiveE< Real >::gradient(), ROL::ObjectiveMMA< Real >::gradient(), ROL::TrustRegionModel< Real >::gradient(), ROL::KelleySachsModel< Real >::gradient(), ROL::TrustRegionModel_U< Real >::gradient(), ROL::Reduced_Objective_SimOpt< Real >::gradient(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::ColemanLiModel< Real >::gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::gradient(), ROL::AugmentedLagrangian_SimOpt< Real >::gradient_1(), ROL::gradient_1(), ROL::AugmentedLagrangian_SimOpt< Real >::gradient_2(), ROL::NonlinearLeastSquaresObjective< Real >::hessVec(), ROL::NonlinearLeastSquaresObjective_Dynamic< Real >::hessVec(), ROL::ChainRuleObjective< Real >::hessVec(), ROL::InteriorPoint::PenalizedObjective< Real >::hessVec(), ROL::FletcherObjectiveE< Real >::hessVec(), ROL::ObjectiveMMA< Real >::hessVec(), ROL::QuadraticPenalty< Real >::hessVec(), ROL::KelleySachsModel< Real >::hessVec(), ROL::Reduced_Objective_SimOpt< Real >::hessVec(), ROL::AugmentedLagrangian< Real >::hessVec(), ROL::ColemanLiModel< Real >::hessVec(), ROL::Fletcher< Real >::hessVec(), ROL::BoundFletcher< Real >::hessVec(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_11(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_11(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_12(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_12(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_21(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_21(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_22(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_22(), ROL::KelleySachsModel< Real >::invHessVec(), ROL::KelleySachsModel< Real >::precond(), ROL::KelleySachsModel< Real >::primalTransform(), ROL::DykstraProjection< Real >::project_con(), ROL::DouglasRachfordProjection< Real >::project_con(), ROL::ShiftedProxObjective< Real >::prox(), ROL::l1Objective< Real >::prox(), ROL::RandomizeFeasibleVector(), ROL::ProjectedObjective< Real >::reducedHessVec(), ROL::ProjectedObjective< Real >::reducedInvHessVec(), ROL::ProjectedObjective< Real >::reducedPrecond(), ROL::TypeU::BundleAlgorithm< Real >::run(), ROL::TypeB::LSecantBAlgorithm< Real >::run(), ROL::TypeB::KelleySachsAlgorithm< Real >::run(), ROL::TypeU::TrustRegionAlgorithm< Real >::run(), ROL::GMRES< Real >::run(), ROL::TypeB::ColemanLiAlgorithm< Real >::run(), ROL::TypeU::Algorithm< Real >::run(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::run(), ROL::TypeB::LinMoreAlgorithm< Real >::run(), ROL::TypeU::LineSearchAlgorithm< Real >::run(), ROL::TypeP::TrustRegionAlgorithm< Real >::run(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::run(), ROL::Vector< Real >::set(), ROL::FletcherObjectiveE< Real >::solveAugmentedSystem(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::Fletcher< Real >::solveAugmentedSystem(), ROL::BoundFletcher< Real >::solveAugmentedSystem(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::TypeE::CompositeStepAlgorithm< Real >::solveTangentialSubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::NewtonStep< Real >::update(), ROL::GradientStep< Real >::update(), ROL::NonlinearCGStep< Real >::update(), ROL::ProjectedNewtonStep< Real >::update(), ROL::SecantStep< Real >::update(), ROL::ProjectedSecantStep< Real >::update(), ROL::TrustRegion< Real >::update(), ROL::NewtonKrylovStep< Real >::update(), ROL::ProjectedNewtonKrylovStep< Real >::update(), ROL::CompositeStep< Real >::update(), ROL::InteriorPointStep< Real >::update(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::BundleStep< Real >::update(), ROL::AugmentedLagrangianStep< Real >::update(), ROL::PrimalDualActiveSetStep< Real >::update(), ROL::SemismoothNewtonProjection< Real >::update_primal(), ROL::TypeE::CompositeStepAlgorithm< Real >::updateRadius(), ROL::LinearConstraint< Real >::value(), and ROL::ElasticLinearConstraint< Real >::value().
|
pure virtual |
Compute \(y \leftarrow \alpha y\) where \(y = \mathtt{*this}\).
[in] | alpha | is the scaling of \(\mathtt{*this}\). |
On return \(\mathtt{*this} = \alpha (\mathtt{*this}) \).
Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::RiskVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::SimulatedVector< Real >, OptStdVector< Real, Element >, ROL::StdArray< Real, array_size, pool_size >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::ElementwiseVector< Real >.
Referenced by ROL::DyadicOperator< Real >::apply(), ROL::SemismoothNewtonProjection< Real >::Precond::apply(), ROL::ConstraintFromObjective< Real >::applyAdjointHessian(), ROL::BinaryConstraint< Real >::applyAdjointHessian(), ROL::Constraint< Real >::applyAdjointHessian(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::UpperBoundToConstraint< Real >::applyAdjointJacobian(), ROL::ConstraintFromObjective< Real >::applyAdjointJacobian(), ROL::ScalarLinearConstraint< Real >::applyAdjointJacobian(), ROL::CompositeConstraint_SimOpt< Real >::applyAdjointSens(), ROL::Secant< Real >::applyB0(), ROL::lSR1< Real >::applyB0(), ROL::Secant< Real >::applyH0(), ROL::lSR1< Real >::applyH0(), ROL::SemismoothNewtonProjection< Real >::Precond::applyInverse(), ROL::UpperBoundToConstraint< Real >::applyJacobian(), ROL::BinaryConstraint< Real >::applyJacobian(), ROL::Constraint< Real >::applyJacobian(), ROL::Constraint_SimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_2(), ROL::CompositeConstraint_SimOpt< Real >::applySens(), ROL::Newton_U< Real >::compute(), ROL::Gradient_U< Real >::compute(), ROL::NewtonStep< Real >::compute(), ROL::GradientStep< Real >::compute(), ROL::QuasiNewton_U< Real >::compute(), ROL::NonlinearCG_U< Real >::compute(), ROL::ProjectedNewtonStep< Real >::compute(), ROL::NonlinearCGStep< Real >::compute(), ROL::ProjectedSecantStep< Real >::compute(), ROL::SecantStep< Real >::compute(), ROL::NewtonKrylov_U< Real >::compute(), ROL::BundleStep< Real >::compute(), ROL::NewtonKrylovStep< Real >::compute(), ROL::ProjectedNewtonKrylovStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), ROL::ReducedDynamicObjective< Real >::computeNewStateJacobian(), ROL::TypeE::CompositeStepAlgorithm< Real >::computeQuasinormalStep(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::LinMore< Real >::dcauchy(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dproj(), ROL::TypeP::TrustRegionAlgorithm< Real >::dprox(), ROL::TypeB::LSecantBAlgorithm< Real >::dsrch(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::CoherentEntropicRisk< Real >::getGradient(), ROL::EntropicRisk< Real >::getGradient(), ROL::BPOE< Real >::getGradient(), ROL::KLDivergence< Real >::getGradient(), ROL::PD_HMCR2< Real >::getGradient(), ROL::HMCR< Real >::getGradient(), ROL::MeanVariance< Real >::getGradient(), ROL::CoherentEntropicRisk< Real >::getHessVec(), ROL::EntropicRisk< Real >::getHessVec(), ROL::BPOE< Real >::getHessVec(), ROL::KLDivergence< Real >::getHessVec(), ROL::PD_HMCR2< Real >::getHessVec(), ROL::HMCR< Real >::getHessVec(), ROL::MeanVariance< Real >::getHessVec(), ROL::ScaledObjective< Real >::gradient(), ROL::ZOO::Objective_SumOfSquares< Real >::gradient(), ROL::LogBarrierObjective< Real >::gradient(), ROL::ConicApproximationModel< Real >::gradient(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::PH_ErrorObjective< Real >::gradient(), ROL::PH_RegretObjective< Real >::gradient(), ROL::PH_ProbObjective< Real >::gradient(), ROL::AugmentedLagrangianObjective< Real >::gradient(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::AugmentedLagrangian_SimOpt< Real >::gradient_1(), ROL::AugmentedLagrangian_SimOpt< Real >::gradient_2(), ROL::DynamicTrackingObjective< Real >::gradient_un(), ROL::DynamicTrackingFEMObjective< Real >::gradient_un(), ROL::DynamicTrackingObjective< Real >::gradient_uo(), ROL::DynamicTrackingObjective< Real >::gradient_z(), ROL::DynamicTrackingFEMObjective< Real >::gradient_z(), ROL::ScaledObjective< Real >::hessVec(), ROL::ZOO::Objective_HS24< Real >::hessVec(), ROL::ConicApproximationModel< Real >::hessVec(), ROL::PH_ErrorObjective< Real >::hessVec(), ROL::PH_RegretObjective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::FletcherObjectiveE< Real >::hessVec(), ROL::QuadraticPenalty< Real >::hessVec(), ROL::AugmentedLagrangianObjective< Real >::hessVec(), ROL::AugmentedLagrangian< Real >::hessVec(), ROL::Fletcher< Real >::hessVec(), ROL::Objective_SimOpt< Real >::hessVec_11(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_11(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_11(), ROL::Objective_SimOpt< Real >::hessVec_12(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_12(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_12(), ROL::Objective_SimOpt< Real >::hessVec_21(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_21(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_21(), ROL::Objective_SimOpt< Real >::hessVec_22(), ROL::AugmentedLagrangian_SimOpt< Real >::hessVec_22(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_22(), ROL::DynamicTrackingObjective< Real >::hessVec_un_un(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_un_un(), ROL::DynamicTrackingObjective< Real >::hessVec_uo_uo(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_uo_uo(), ROL::DynamicTrackingObjective< Real >::hessVec_z_z(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_z_z(), ROL::ScaledObjective< Real >::invHessVec(), ROL::ZOO::Objective_SumOfSquares< Real >::invHessVec(), ROL::ConicApproximationModel< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), ROL::ScaledObjective< Real >::precond(), ROL::ConicApproximationModel< Real >::precond(), ROL::ColemanLiModel< Real >::primalTransform(), ROL::DykstraProjection< Real >::project_con(), ROL::DouglasRachfordProjection< Real >::project_con(), ROL::l1Objective< Real >::prox(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_hessVec(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TypeE::AugmentedLagrangianAlgorithm< Real >::run(), ROL::CauchyPoint_U< Real >::solve(), ROL::DoubleDogLeg_U< Real >::solve(), ROL::DogLeg_U< Real >::solve(), ROL::SPGTrustRegion_U< Real >::solve(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::BinaryConstraint< Real >::value(), and ROL::Vector< Real >::zero().
|
pure virtual |
Compute \( \langle y,x \rangle \) where \(y = \mathtt{*this}\).
[in] | x | is the vector that forms the dot product with \(\mathtt{*this}\). |
Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, H1VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ROL::DualSimulatedVector< Real >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ROL::PrimalSimulatedVector< Real >, ConStdVector< Real, Element >, ROL::RiskVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::RieszDualVector< Real >, ROL::DualAtomVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::DualProbabilityVector< Real >, ROL::DualScaledStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::SimulatedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::PrimalAtomVector< Real >, ROL::PartitionedVector< Real >, ROL::PrimalProbabilityVector< Real >, OptStdVector< Real, Element >, ROL::RieszPrimalVector< Real >, OptStdVector< Real, Element >, ROL::StdArray< Real, array_size, pool_size >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, ROL::PrimalScaledStdVector< Real, Element >, ROL::ElementwiseVector< Real >, and ROL::BatchStdVector< Real >.
Referenced by ROL::TypeE::CompositeStepAlgorithm< Real >::accept(), ROL::CompositeStep< Real >::accept(), ROL::Sketch< Real >::advance(), ROL::DyadicOperator< Real >::apply(), ROL::NullSpaceOperator< Real >::apply(), ROL::Vector< Real >::apply(), ROL::BundleStep< Real >::compute(), ROL::TypeB::LSecantBAlgorithm< Real >::dcauchy(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dcauchy(), ROL::TypeB::LinMoreAlgorithm< Real >::dcauchy(), ROL::TypeP::TrustRegionAlgorithm< Real >::dcauchy(), ROL::LinMore< Real >::dcauchy(), ROL::ZOO::Objective_Zakharov< Real >::dirDeriv(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::Bundle_U< Real >::dotGi(), ROL::Bundle< Real >::dotGi(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dprsrch(), ROL::LinMore< Real >::dprsrch(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg_simple(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::LineSearchStep< Real >::GradDotStep(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::Objective< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::TRUtils::initialRadius(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), ROL::SemismoothNewtonProjection< Real >::project_ssn(), ROL::DoubleDogLeg< Real >::run(), ROL::LinMore< Real >::run(), ROL::DoubleDogLeg_U< Real >::solve(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::TypeE::CompositeStepAlgorithm< Real >::solveTangentialSubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::LineSearch< Real >::status(), ROL::TrustRegion< Real >::update(), ROL::Objective_FSsolver< Real >::value(), ROL::ZOO::Objective_SumOfSquares< Real >::value(), ROL::LinearObjective< Real >::value(), ROL::DynamicTrackingFEMObjective< Real >::value(), ROL::DynamicTrackingObjective< Real >::value(), ROL::ZOO::Objective_Zakharov< Real >::value(), and ROL::PH_Objective< Real >::value().
|
pure virtual |
Returns \( \| y \| \) where \(y = \mathtt{*this}\).
Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, ROL::RiskVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::SimulatedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::StdArray< Real, array_size, pool_size >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::ElementwiseVector< Real >.
Referenced by ROL::TypeE::CompositeStepAlgorithm< Real >::accept(), ROL::CompositeStep< Real >::accept(), ROL::Sketch< Real >::advance(), ROL::Constraint< Real >::applyAdjointHessian(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::Constraint< Real >::applyJacobian(), ROL::Constraint_SimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_2(), ROL::Constraint_SimOpt< Real >::checkInverseAdjointJacobian_1(), ROL::Constraint_TimeSimOpt< Real >::checkInverseAdjointJacobian_1_new(), ROL::Constraint_SimOpt< Real >::checkInverseJacobian_1(), ROL::Constraint_TimeSimOpt< Real >::checkInverseJacobian_1_new(), ROL::Newton_U< Real >::compute(), ROL::Gradient_U< Real >::compute(), ROL::QuasiNewton_U< Real >::compute(), ROL::NonlinearCG_U< Real >::compute(), ROL::NewtonKrylov_U< Real >::compute(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::TrustRegionStep< Real >::computeCriticalityMeasure(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), ROL::TypeP::TrustRegionAlgorithm< Real >::computeGradient(), ROL::FletcherObjectiveBase< Real >::computeMultipliers(), ROL::FletcherStep< Real >::computeProjGradientNorm(), ROL::LinMore< Real >::dbreakpt(), ROL::TypeP::TrustRegionAlgorithm< Real >::dcauchy(), ROL::TypeB::LSecantBAlgorithm< Real >::dgpstep(), ROL::TypeB::ColemanLiAlgorithm< Real >::dgpstep(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dgpstep(), ROL::TypeB::LinMoreAlgorithm< Real >::dgpstep(), ROL::LinMore< Real >::dgpstep(), ROL::LineSearch_U< Real >::dirDeriv(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dproj(), ROL::TypeP::TrustRegionAlgorithm< Real >::dprox(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg_simple(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::TypeB::LSecantBAlgorithm< Real >::dsrch(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::ColemanLiModel< Real >::getScalarBounds(), ROL::InteriorPoint::PenalizedObjective< Real >::gradient(), ROL::Objective< Real >::hessVec(), ROL::Objective_SimOpt< Real >::hessVec_11(), ROL::Objective_SimOpt< Real >::hessVec_12(), ROL::Objective_SimOpt< Real >::hessVec_21(), ROL::Objective_SimOpt< Real >::hessVec_22(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::initialize(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeU::TrustRegionAlgorithm< Real >::initialize(), ROL::TypeP::InexactNewtonAlgorithm< Real >::initialize(), ROL::TypeB::Algorithm< Real >::optimalityCriterion(), ROL::DouglasRachfordProjection< Real >::project_DouglasRachford(), ROL::DykstraProjection< Real >::project_Dykstra(), ROL::Sketch< Real >::reconstruct(), ROL::SemismoothNewtonProjection< Real >::residual(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::run(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::run(), ROL::LinMore< Real >::run(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::run(), ROL::CauchyPoint_U< Real >::solve(), ROL::DoubleDogLeg_U< Real >::solve(), ROL::DogLeg_U< Real >::solve(), ROL::SPGTrustRegion_U< Real >::solve(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), Constraint_BurgersControl< Real >::solve(), ROL::TypeE::CompositeStepAlgorithm< Real >::solveTangentialSubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::NewtonStep< Real >::update(), ROL::GradientStep< Real >::update(), ROL::ProjectedNewtonStep< Real >::update(), ROL::NonlinearCGStep< Real >::update(), ROL::SecantStep< Real >::update(), ROL::ProjectedSecantStep< Real >::update(), ROL::NewtonKrylovStep< Real >::update(), ROL::ProjectedNewtonKrylovStep< Real >::update(), ROL::InteriorPointStep< Real >::update(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::AugmentedLagrangianStep< Real >::update(), ROL::PrimalDualActiveSetStep< Real >::update(), ROL::TypeB::MoreauYosidaAlgorithm< Real >::updateState(), ROL::TypeB::InteriorPointAlgorithm< Real >::updateState(), ROL::TypeG::MoreauYosidaAlgorithm< Real >::updateState(), and ROL::TypeG::InteriorPointAlgorithm< Real >::updateState().
|
pure virtual |
Clone to make a new (uninitialized) vector.
Provides the means of allocating temporary memory in ROL.
Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, H1VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ROL::DualSimulatedVector< Real >, ConDualStdVector< Real, Element >, ROL::PrimalSimulatedVector< Real >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, ROL::RiskVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::DualAtomVector< Real >, ROL::RieszDualVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::DualProbabilityVector< Real >, OptStdVector< Real, Element >, ROL::DualScaledStdVector< Real, Element >, ROL::SimulatedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::PrimalAtomVector< Real >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, ROL::PrimalProbabilityVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::RieszPrimalVector< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, ROL::PrimalScaledStdVector< Real, Element >, ROL::ProbabilityVector< Real >, and ROL::BatchStdVector< Real >.
Referenced by ROL::AffineTransformConstraint< Real >::AffineTransformConstraint(), ROL::AffineTransformObjective< Real >::AffineTransformObjective(), ROL::VectorController< Real, Key >::allocate(), ROL::AlmostSureConstraint< Real >::applyAdjointHessian(), ROL::Constraint< Real >::applyAdjointHessian(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::AlmostSureConstraint< Real >::applyAdjointJacobian(), ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::ConstraintFromObjective< Real >::applyJacobian(), ROL::Constraint< Real >::applyJacobian(), ROL::Constraint_SimOpt< Real >::applyJacobian(), ROL::Constraint_SimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_2(), ROL::Constraint_DynamicState< Real >::applyPreconditioner(), ROL::AugmentedLagrangianObjective< Real >::AugmentedLagrangianObjective(), ROL::Vector< Real >::axpy(), ROL::BoundConstraint< Real >::BoundConstraint(), ROL::BoundFletcher< Real >::BoundFletcher(), ROL::Bounds< Real >::Bounds(), ROL::BoundToConstraint< Real >::BoundToConstraint(), ROL::DynamicConstraintCheck< Real >::check(), ROL::DynamicObjectiveCheck< Real >::check(), ROL::Constraint< Real >::checkAdjointConsistencyJacobian(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_1(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_2(), ROL::Constraint< Real >::checkApplyAdjointHessian(), ROL::Constraint_SimOpt< Real >::checkApplyAdjointHessian_11(), ROL::Constraint_SimOpt< Real >::checkApplyAdjointHessian_12(), ROL::Constraint_SimOpt< Real >::checkApplyAdjointHessian_21(), ROL::Constraint_SimOpt< Real >::checkApplyAdjointHessian_22(), ROL::Constraint< Real >::checkApplyAdjointJacobian(), ROL::Constraint< Real >::checkApplyJacobian(), ROL::Constraint_SimOpt< Real >::checkApplyJacobian_1(), ROL::Constraint_SimOpt< Real >::checkApplyJacobian_2(), ROL::Objective< Real >::checkGradient(), ROL::Objective_SimOpt< Real >::checkGradient_1(), ROL::Objective_SimOpt< Real >::checkGradient_2(), ROL::Objective< Real >::checkHessSym(), ROL::Objective< Real >::checkHessVec(), ROL::Objective_SimOpt< Real >::checkHessVec_11(), ROL::Objective_SimOpt< Real >::checkHessVec_12(), ROL::Objective_SimOpt< Real >::checkHessVec_21(), ROL::Objective_SimOpt< Real >::checkHessVec_22(), ROL::Constraint_SimOpt< Real >::checkInverseAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::checkInverseJacobian_1(), ROL::Constraint_SimOpt< Real >::checkSolve(), ROL::Vector< Real >::checkVector(), ROL::details::VectorWorkspace< Real >::VectorStack::clone(), ROL::CompositeConstraint_SimOpt< Real >::CompositeConstraint_SimOpt(), ROL::computeDenseHessian(), ROL::computeDotMatrix(), ROL::BoundConstraint< Real >::computeProjectedGradient(), ROL::computeScaledDenseHessian(), ROL::PartitionedVector< Real >::create(), createDiagonalQuadraticObjective(), ROL::LogBarrierObjective< Real >::dirDeriv(), ROL::Objective< Real >::dirDeriv(), ROL::ElementwiseVector< Real >::dot(), ROL::DouglasRachfordProjection< Real >::DouglasRachfordProjection(), ROL::DykstraProjection< Real >::DykstraProjection(), ROL::Fletcher< Real >::Fletcher(), ROL::FletcherObjectiveBase< Real >::FletcherObjectiveBase(), ROL::FletcherObjectiveE< Real >::FletcherObjectiveE(), ROL::VectorController< Real, Key >::get(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::Objective< Real >::gradient(), Objective_GrossPitaevskii< Real >::gradient(), ROL::LinearCombinationObjective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::LinearCombinationObjective_SimOpt< Real >::gradient_2(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::LinearCombinationObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_11(), ROL::Objective_SimOpt< Real >::hessVec_11(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_12(), ROL::Objective_SimOpt< Real >::hessVec_12(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_21(), ROL::Objective_SimOpt< Real >::hessVec_21(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_22(), ROL::Objective_SimOpt< Real >::hessVec_22(), ROL::RiskNeutralConstraint< Real >::init(), ROL::DoubleDogLeg_U< Real >::initialize(), ROL::CauchyPoint_U< Real >::initialize(), ROL::DogLeg_U< Real >::initialize(), ROL::IterationScaling_U< Real >::initialize(), ROL::IterationScaling< Real >::initialize(), ROL::CubicInterp< Real >::initialize(), ROL::CubicInterp_U< Real >::initialize(), ROL::BackTracking< Real >::initialize(), ROL::BackTracking_U< Real >::initialize(), ROL::DaiFletcherProjection< Real >::initialize(), ROL::DogLeg< Real >::initialize(), ROL::RiddersProjection< Real >::initialize(), ROL::GoldenSection< Real >::initialize(), ROL::BrentsProjection< Real >::initialize(), ROL::Bisection< Real >::initialize(), ROL::DoubleDogLeg< Real >::initialize(), ROL::TruncatedCG_U< Real >::initialize(), ROL::PathBasedTargetLevel_U< Real >::initialize(), ROL::PathBasedTargetLevel< Real >::initialize(), ROL::Brents< Real >::initialize(), ROL::Bundle_U_AS< Real >::initialize(), ROL::Bundle_AS< Real >::initialize(), ROL::CompositeObjective< Real >::initialize(), ROL::TruncatedCG< Real >::initialize(), ROL::TypeBIndicatorObjective< Real >::initialize(), ROL::TypeU::Algorithm< Real >::initialize(), ROL::ProjectedNewtonStep< Real >::initialize(), ROL::SPGTrustRegion_U< Real >::initialize(), ROL::TypeB::Algorithm< Real >::initialize(), ROL::TypeE::Algorithm< Real >::initialize(), ROL::TypeP::Algorithm< Real >::initialize(), ROL::Step< Real >::initialize(), ROL::TypeG::Algorithm< Real >::initialize(), ROL::Bundle_U< Real >::initialize(), ROL::ProjectedSecantStep< Real >::initialize(), ROL::TypeE::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::SecantStep< Real >::initialize(), ROL::TypeE::StabilizedLCLAlgorithm< Real >::initialize(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::initialize(), ROL::TrustRegionModel_U< Real >::initialize(), ROL::TypeE::CompositeStepAlgorithm< Real >::initialize(), ROL::LineSearch< Real >::initialize(), ROL::TrustRegion< Real >::initialize(), ROL::MoreauYosidaPenalty< Real >::initialize(), ROL::LinMore< Real >::initialize(), ROL::MoreauYosidaObjective< Real >::initialize(), ROL::InteriorPointObjective< Real >::initialize(), ROL::Bundle< Real >::initialize(), ROL::LineSearch_U< Real >::initialize(), ROL::InteriorPointStep< Real >::initialize(), ROL::FletcherStep< Real >::initialize(), ROL::BundleStep< Real >::initialize(), ROL::NewtonKrylovStep< Real >::initialize(), ROL::ColemanLiModel< Real >::initialize(), ROL::CompositeStep< Real >::initialize(), ROL::LineSearchStep< Real >::initialize(), ROL::MoreauYosidaPenaltyStep< Real >::initialize(), ROL::ProjectedNewtonKrylovStep< Real >::initialize(), ROL::ScalarMinimizationLineSearch< Real >::initialize(), ROL::ScalarMinimizationLineSearch_U< Real >::initialize(), ROL::AugmentedLagrangianStep< Real >::initialize(), ROL::PrimalDualActiveSetStep< Real >::initialize(), ROL::TrustRegionStep< Real >::initialize(), ROL::TRUtils::initialRadius(), ROL::BoundConstraint< Real >::isFeasible(), ROL::KelleySachsModel< Real >::KelleySachsModel(), ROL::LinMoreModel< Real >::LinMoreModel(), ROL::LowerBoundToConstraint< Real >::LowerBoundToConstraint(), ROL::NonlinearLeastSquaresObjective< Real >::NonlinearLeastSquaresObjective(), ROL::NonlinearLeastSquaresObjective_Dynamic< Real >::NonlinearLeastSquaresObjective_Dynamic(), ROL::normL1(), ROL::normLinf(), ROL::normLp(), ROL::NullSpaceOperator< Real >::NullSpaceOperator(), ROL::ObjectiveMMA< Real >::ObjectiveMMA(), ROL::details::VectorClone< Real >::operator()(), ROL::InteriorPoint::PenalizedObjective< Real >::PenalizedObjective(), ROL::PH_StatusTest< Real >::PH_StatusTest(), ROL::PolyhedralProjection< Real >::PolyhedralProjection(), ROL::InteriorPoint::PrimalDualSymmetrizer< Real >::PrimalDualSymmetrizer(), ROL::BoundConstraint< Real >::pruneInactive(), ROL::BoundConstraint< Real >::pruneLowerInactive(), ROL::BoundConstraint< Real >::pruneUpperInactive(), ROL::QuadraticPenalty< Real >::QuadraticPenalty(), ROL::QuadraticPenalty_SimOpt< Real >::QuadraticPenalty_SimOpt(), ROL::ProjectedObjective< Real >::reducedHessVec(), ROL::ProjectedObjective< Real >::reducedInvHessVec(), ROL::ProjectedObjective< Real >::reducedPrecond(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::TypeB::SpectralGradientAlgorithm< Real >::run(), ROL::TypeB::GradientAlgorithm< Real >::run(), ROL::TypeP::ProxGradientAlgorithm< Real >::run(), ROL::TypeP::SpectralGradientAlgorithm< Real >::run(), ROL::TypeP::iPianoAlgorithm< Real >::run(), ROL::TypeE::FletcherAlgorithm< Real >::run(), ROL::TypeB::QuasiNewtonAlgorithm< Real >::run(), ROL::TypeP::QuasiNewtonAlgorithm< Real >::run(), ROL::TypeB::MoreauYosidaAlgorithm< Real >::run(), ROL::TypeU::BundleAlgorithm< Real >::run(), ROL::TypeB::InteriorPointAlgorithm< Real >::run(), ROL::TypeB::LSecantBAlgorithm< Real >::run(), ROL::TypeG::MoreauYosidaAlgorithm< Real >::run(), ROL::TypeB::KelleySachsAlgorithm< Real >::run(), ROL::TypeU::TrustRegionAlgorithm< Real >::run(), ROL::GMRES< Real >::run(), ROL::TypeG::InteriorPointAlgorithm< Real >::run(), ROL::TypeB::ColemanLiAlgorithm< Real >::run(), ROL::TypeE::StabilizedLCLAlgorithm< Real >::run(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::run(), ROL::TypeU::Algorithm< Real >::run(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::run(), ROL::TypeB::LinMoreAlgorithm< Real >::run(), ROL::Algorithm< Real >::run(), ROL::TypeU::LineSearchAlgorithm< Real >::run(), ROL::TypeP::InexactNewtonAlgorithm< Real >::run(), ROL::TypeE::Algorithm< Real >::run(), ROL::TypeB::Algorithm< Real >::run(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::run(), ROL::TypeG::Algorithm< Real >::run(), ROL::TypeP::TrustRegionAlgorithm< Real >::run(), ROL::TypeE::CompositeStepAlgorithm< Real >::run(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::run(), ROL::SemismoothNewtonProjection< Real >::SemismoothNewtonProjection(), ROL::SampledVector< Real, Key >::set(), ROL::VectorController< Real, Key >::set(), ROL::Sketch< Real >::Sketch(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::Constraint< Real >::solveAugmentedSystem(), Objective_PoissonInversion< Real >::update(), ROL::lSR1< Real >::updateStorage(), ROL::Secant< Real >::updateStorage(), ROL::UpperBoundToConstraint< Real >::UpperBoundToConstraint(), ROL::TrustRegionModel_U< Real >::validate(), ROL::LogBarrierObjective< Real >::value(), Objective_GrossPitaevskii< Real >::value(), and CLExactModel< Real >::value().
|
inlinevirtual |
Compute \(y \leftarrow \alpha x + y\) where \(y = \mathtt{*this}\).
[in] | alpha | is the scaling of x. |
[in] | x | is a vector. |
On return \(\mathtt{*this} = \mathtt{*this} + \alpha x \). Uses clone, set, scale and plus for the computation. Please overload if a more efficient implementation is needed.
Reimplemented in ROL::RiskVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::SimulatedVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::SROMVector< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::ElementwiseVector< Real >, ROL::SingletonVector< Real >, and ROL::Vector_SimOpt< Real >.
Definition at line 119 of file ROL_Vector.hpp.
References ROL::Vector< Real >::clone(), and ROL::Vector< Real >::plus().
Referenced by ROL::Bundle_U< Real >::addGi(), ROL::Bundle< Real >::addGi(), ROL::ReducedDynamicObjective< Real >::addMixedHessLag(), ROL::BlockOperator2Determinant< Real >::apply(), ROL::HouseholderReflector< Real >::apply(), ROL::SemismoothNewtonProjection< Real >::Jacobian::apply(), ROL::NullSpaceOperator< Real >::apply(), ROL::BinaryConstraint< Real >::applyAdjointHessian(), ROL::Constraint< Real >::applyAdjointHessian(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::CompositeConstraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::Constraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::lSR1< Real >::applyB(), ROL::lSR1< Real >::applyH(), ROL::ElasticLinearConstraint< Real >::applyJacobian(), ROL::BinaryConstraint< Real >::applyJacobian(), ROL::Constraint< Real >::applyJacobian(), ROL::Constraint_TimeSimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_2(), ROL::Bounds< Real >::applyScalingFunctionJacobian(), ROL::Bounds< Real >::buildScalingFunction(), calcError(), ROL::InteriorPointStep< Real >::compute(), ROL::MoreauYosidaPenaltyStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::AugmentedLagrangianStep< Real >::compute(), ROL::ReducedDynamicObjective< Real >::computeAdjointRHS(), ROL::ReducedDynamicObjective< Real >::computeControlHessLag(), ROL::ReducedDynamicObjective< Real >::computeNewMixedHessLag(), ROL::ReducedDynamicObjective< Real >::computeNewStateHessLag(), ROL::ReducedDynamicObjective< Real >::computeNewStateJacobian(), ROL::ReducedDynamicObjective< Real >::computeOldMixedHessLag(), ROL::ReducedDynamicObjective< Real >::computeOldStateHessLag(), ROL::BoundConstraint< Real >::computeProjectedStep(), ROL::TypeE::CompositeStepAlgorithm< Real >::computeQuasinormalStep(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::TypeP::TrustRegionAlgorithm< Real >::dbls(), ROL::LinMore< Real >::dbreakpt(), ROL::TypeB::LSecantBAlgorithm< Real >::dgpstep(), ROL::TypeB::ColemanLiAlgorithm< Real >::dgpstep(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dgpstep(), ROL::TypeB::LinMoreAlgorithm< Real >::dgpstep(), ROL::LinMore< Real >::dgpstep(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dproj(), ROL::TypeP::TrustRegionAlgorithm< Real >::dprox(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg_simple(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::TypeB::LSecantBAlgorithm< Real >::dsrch(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::ConvexCombinationRiskMeasure< Real >::getGradient(), ROL::HMCR< Real >::getGradient(), ROL::MeanDeviationFromTarget< Real >::getGradient(), ROL::CoherentEntropicRisk< Real >::getHessVec(), ROL::EntropicRisk< Real >::getHessVec(), ROL::BPOE< Real >::getHessVec(), ROL::KLDivergence< Real >::getHessVec(), ROL::PD_HMCR2< Real >::getHessVec(), ROL::ConvexCombinationRiskMeasure< Real >::getHessVec(), ROL::HMCR< Real >::getHessVec(), ROL::MeanVariance< Real >::getHessVec(), ROL::MeanDeviationFromTarget< Real >::getHessVec(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::CompositeObjective< Real >::gradient(), ROL::l1Objective< Real >::gradient(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::ReducedDynamicStationaryControlsObjective< Real >::gradient(), ROL::Objective< Real >::gradient(), ROL::FletcherObjectiveE< Real >::gradient(), ROL::AugmentedLagrangianObjective< Real >::gradient(), ROL::InteriorPointObjective< Real >::gradient(), ROL::InteriorPointPenalty< Real >::gradient(), ROL::MoreauYosidaPenalty< Real >::gradient(), ROL::MoreauYosidaObjective< Real >::gradient(), ROL::LinearCombinationObjective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::CompositeObjective_SimOpt< Real >::gradient_1(), ROL::LinearCombinationObjective_SimOpt< Real >::gradient_2(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::CompositeObjective_SimOpt< Real >::gradient_2(), ROL::DynamicTrackingObjective< Real >::gradient_un(), ROL::DynamicTrackingFEMObjective< Real >::gradient_un(), ROL::DynamicTrackingObjective< Real >::gradient_uo(), ROL::LinearCombinationObjective< Real >::hessVec(), ROL::CompositeObjective< Real >::hessVec(), ROL::ConicApproximationModel< Real >::hessVec(), ROL::ReducedDynamicStationaryControlsObjective< Real >::hessVec(), ROL::PH_ErrorObjective< Real >::hessVec(), ROL::PH_RegretObjective< Real >::hessVec(), ROL::PH_Objective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::FletcherObjectiveE< Real >::hessVec(), ROL::AugmentedLagrangianObjective< Real >::hessVec(), ROL::InteriorPointObjective< Real >::hessVec(), ROL::Fletcher< Real >::hessVec(), ROL::MoreauYosidaPenalty< Real >::hessVec(), ROL::InteriorPointPenalty< Real >::hessVec(), ROL::MoreauYosidaObjective< Real >::hessVec(), ROL::BoundFletcher< Real >::hessVec(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_11(), ROL::Objective_SimOpt< Real >::hessVec_11(), ROL::CompositeObjective_SimOpt< Real >::hessVec_11(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_12(), ROL::Objective_SimOpt< Real >::hessVec_12(), ROL::CompositeObjective_SimOpt< Real >::hessVec_12(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_21(), ROL::Objective_SimOpt< Real >::hessVec_21(), ROL::CompositeObjective_SimOpt< Real >::hessVec_21(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_22(), ROL::Objective_SimOpt< Real >::hessVec_22(), ROL::CompositeObjective_SimOpt< Real >::hessVec_22(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_uo_uo(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::initialize(), ROL::ConicApproximationModel< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), ROL::TypeB::Algorithm< Real >::optimalityCriterion(), ROL::TypeP::Algorithm< Real >::pgstep(), ROL::ConicApproximationModel< Real >::precond(), ROL::KelleySachsModel< Real >::primalTransform(), ROL::DykstraProjection< Real >::project_con(), ROL::DouglasRachfordProjection< Real >::project_con(), ROL::SemismoothNewtonProjection< Real >::project_ssn(), ROL::ShiftedProxObjective< Real >::prox(), ROL::BallIndicatorObjective< Real >::prox(), ROL::l1Objective< Real >::prox(), ROL::BoundConstraint< Real >::pruneInactive(), ROL::BoundConstraint< Real >::pruneLowerInactive(), ROL::BoundConstraint< Real >::pruneUpperInactive(), ROL::RandomizeFeasibleVector(), ROL::Sketch< Real >::reconstruct(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::TypeE::AugmentedLagrangianAlgorithm< Real >::run(), ROL::details::MINRES< Real >::run(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::run(), ROL::TypeE::StabilizedLCLAlgorithm< Real >::run(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::run(), ROL::LinMore< Real >::run(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::run(), ROL::DoubleDogLeg_U< Real >::solve(), ROL::DogLeg_U< Real >::solve(), ROL::TruncatedCG_U< Real >::solve(), ROL::SPGTrustRegion_U< Real >::solve(), ROL::ScalarLinearConstraint< Real >::solveAugmentedSystem(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::AugmentedLagrangianStep< Real >::update(), ROL::BrentsProjection< Real >::update_primal(), ROL::DaiFletcherProjection< Real >::update_primal(), ROL::RiddersProjection< Real >::update_primal(), ROL::ReducedDynamicObjective< Real >::updateGradient(), ROL::LineSearch< Real >::updateIterate(), ROL::TypeB::MoreauYosidaAlgorithm< Real >::updateState(), ROL::TypeB::InteriorPointAlgorithm< Real >::updateState(), ROL::TypeG::MoreauYosidaAlgorithm< Real >::updateState(), ROL::TypeG::InteriorPointAlgorithm< Real >::updateState(), ROL::UpperBoundToConstraint< Real >::value(), ROL::LowerBoundToConstraint< Real >::value(), ROL::ElasticLinearConstraint< Real >::value(), and ROL::BinaryConstraint< Real >::value().
|
inlinevirtual |
Set to zero vector.
Uses scale by zero for the computation. Please overload if a more efficient implementation is needed.
Reimplemented in ROL::SimulatedVector< Real >, ROL::PartitionedVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::StdArray< Real, array_size, pool_size >, and ROL::ElementwiseVector< Real >.
Definition at line 133 of file ROL_Vector.hpp.
References ROL::Vector< Real >::scale().
Referenced by ROL::Bundle_U< Real >::aggregate(), ROL::Bundle< Real >::aggregate(), ROL::NullOperator< Real >::apply(), ROL::UpperBoundToConstraint< Real >::applyAdjointHessian(), ROL::LowerBoundToConstraint< Real >::applyAdjointHessian(), ROL::BoundToConstraint< Real >::applyAdjointHessian(), ROL::LinearConstraint< Real >::applyAdjointHessian(), ROL::ElasticLinearConstraint< Real >::applyAdjointHessian(), ROL::ReducedLinearConstraint< Real >::applyAdjointHessian(), ROL::ScalarLinearConstraint< Real >::applyAdjointHessian(), ROL::RiskNeutralConstraint< Real >::applyAdjointHessian(), ROL::AlmostSureConstraint< Real >::applyAdjointHessian(), ROL::ZOO::EqualityConstraint_HS32< Real >::applyAdjointHessian(), ROL::ZOO::Constraint_HS24< Real >::applyAdjointHessian(), ROL::SimulatedConstraint< Real >::applyAdjointHessian(), ROL::Constraint< Real >::applyAdjointHessian(), ROL::Constraint_SerialSimOpt< Real >::applyAdjointHessian_11(), DiffusionConstraint< Real >::applyAdjointHessian_11(), Constraint_BurgersControl< Real >::applyAdjointHessian_11(), Constraint_BurgersControl< Real >::applyAdjointHessian_12(), ROL::Constraint_TimeSimOpt< Real >::applyAdjointHessian_12(), DiffusionConstraint< Real >::applyAdjointHessian_12(), Constraint_BurgersControl< Real >::applyAdjointHessian_21(), ROL::Constraint_TimeSimOpt< Real >::applyAdjointHessian_21(), DiffusionConstraint< Real >::applyAdjointHessian_21(), ROL::CompositeConstraint_SimOpt< Real >::applyAdjointHessian_22(), Constraint_BurgersControl< Real >::applyAdjointHessian_22(), ROL::Constraint_TimeSimOpt< Real >::applyAdjointHessian_22(), DiffusionConstraint< Real >::applyAdjointHessian_22(), ROL::DynamicConstraint< Real >::applyAdjointHessian_un_un(), ROL::DynamicConstraint< Real >::applyAdjointHessian_un_uo(), ROL::DynamicConstraint< Real >::applyAdjointHessian_un_z(), ROL::DynamicConstraint< Real >::applyAdjointHessian_uo_un(), ROL::DynamicConstraint< Real >::applyAdjointHessian_uo_uo(), ROL::DynamicConstraint< Real >::applyAdjointHessian_uo_z(), ROL::DynamicConstraint< Real >::applyAdjointHessian_z_un(), ROL::DynamicConstraint< Real >::applyAdjointHessian_z_uo(), ROL::DynamicConstraint< Real >::applyAdjointHessian_z_z(), ROL::AlmostSureConstraint< Real >::applyAdjointJacobian(), ROL::RiskNeutralConstraint< Real >::applyAdjointJacobian(), ROL::SimulatedConstraint< Real >::applyAdjointJacobian(), ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::AlmostSureConstraint< Real >::applyJacobian(), ROL::RiskNeutralConstraint< Real >::applyJacobian(), ROL::SimulatedConstraint< Real >::applyJacobian(), ROL::Constraint< Real >::applyJacobian(), ROL::InteriorPoint::PrimalDualResidual< Real >::applyJacobian(), ROL::AlmostSureConstraint< Real >::applyPreconditioner(), ROL::SimulatedConstraint< Real >::applyPreconditioner(), ROL::Vector< Real >::checkVector(), ROL::BundleStep< Real >::compute(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg_simple(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::BPOE< Real >::getGradient(), ROL::ZeroProxObjective< Real >::gradient(), NullObjective< Real >::gradient(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::CompositeObjective< Real >::gradient(), ROL::ZOO::Objective_BVP< Real >::gradient(), ROL::SimulatedObjective< Real >::gradient(), ROL::ZOO::Objective_HS25< Real >::gradient(), ROL::SimulatedObjectiveCVaR< Real >::gradient(), ROL::ReducedDynamicStationaryControlsObjective< Real >::gradient(), ROL::PH_ProbObjective< Real >::gradient(), ROL::Objective< Real >::gradient(), ROL::MomentObjective< Real >::gradient(), ROL::RiskNeutralObjective< Real >::gradient(), ROL::StochasticObjective< Real >::gradient(), ROL::CDFObjective< Real >::gradient(), ROL::LinearObjective_SimOpt< Real >::gradient_1(), ROL::LinearCombinationObjective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::CompositeObjective_SimOpt< Real >::gradient_1(), Objective_BurgersControl< Real >::gradient_1(), ROL::LinearObjective_SimOpt< Real >::gradient_2(), ROL::LinearCombinationObjective_SimOpt< Real >::gradient_2(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::CompositeObjective_SimOpt< Real >::gradient_2(), Objective_BurgersControl< Real >::gradient_2(), ROL::DynamicTrackingObjective< Real >::gradient_uo(), ROL::DynamicTrackingFEMObjective< Real >::gradient_uo(), ROL::LinearCombinationObjective< Real >::hessVec(), NullObjective< Real >::hessVec(), ROL::LinearObjective< Real >::hessVec(), ROL::CompositeObjective< Real >::hessVec(), ROL::ZOO::Objective_HS39< Real >::hessVec(), ROL::SimulatedObjective< Real >::hessVec(), ROL::ReducedDynamicStationaryControlsObjective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::QuadraticPenalty< Real >::hessVec(), ROL::AugmentedLagrangianObjective< Real >::hessVec(), ROL::MomentObjective< Real >::hessVec(), ROL::StochasticObjective< Real >::hessVec(), ROL::RiskNeutralObjective< Real >::hessVec(), ROL::CDFObjective< Real >::hessVec(), ROL::LinearObjective_SimOpt< Real >::hessVec_11(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_11(), ROL::Objective_SimOpt< Real >::hessVec_11(), ObjectiveFunctionTest08_2< Real >::hessVec_11(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_11(), ROL::CompositeObjective_SimOpt< Real >::hessVec_11(), Objective_BurgersControl< Real >::hessVec_11(), ObjectiveFunctionTest08_1< Real >::hessVec_12(), ROL::LinearObjective_SimOpt< Real >::hessVec_12(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_12(), ObjectiveFunctionTest08_2< Real >::hessVec_12(), ROL::Objective_SimOpt< Real >::hessVec_12(), ROL::hessVec_12(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_12(), ROL::CompositeObjective_SimOpt< Real >::hessVec_12(), Objective_BurgersControl< Real >::hessVec_12(), DiffusionObjective< Real >::hessVec_12(), ObjectiveFunctionTest08_1< Real >::hessVec_21(), ROL::LinearObjective_SimOpt< Real >::hessVec_21(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_21(), ObjectiveFunctionTest08_2< Real >::hessVec_21(), ROL::Objective_SimOpt< Real >::hessVec_21(), ROL::hessVec_21(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_21(), ROL::CompositeObjective_SimOpt< Real >::hessVec_21(), Objective_BurgersControl< Real >::hessVec_21(), DiffusionObjective< Real >::hessVec_21(), ROL::LinearObjective_SimOpt< Real >::hessVec_22(), ROL::LinearCombinationObjective_SimOpt< Real >::hessVec_22(), ObjectiveFunctionTest08_2< Real >::hessVec_22(), ROL::Objective_SimOpt< Real >::hessVec_22(), ROL::hessVec_22(), ROL::CompositeObjective_SimOpt< Real >::hessVec_22(), ROL::QuadraticPenalty_SimOpt< Real >::hessVec_22(), Objective_BurgersControl< Real >::hessVec_22(), ROL::DynamicTrackingObjective< Real >::hessVec_un_uo(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_un_uo(), ROL::DynamicTrackingObjective< Real >::hessVec_un_z(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_un_z(), ROL::DynamicTrackingObjective< Real >::hessVec_uo_un(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_uo_un(), ROL::DynamicTrackingObjective< Real >::hessVec_uo_uo(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_uo_uo(), ROL::DynamicTrackingObjective< Real >::hessVec_uo_z(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_uo_z(), ROL::DynamicTrackingObjective< Real >::hessVec_z_un(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_z_un(), ROL::DynamicTrackingObjective< Real >::hessVec_z_uo(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_z_uo(), main(), ROL::Sketch< Real >::reconstruct(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::TypeG::MoreauYosidaAlgorithm< Real >::run(), ROL::GMRES< Real >::run(), ROL::Vector< Real >::set(), ROL::TruncatedCG_U< Real >::solve(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::TypeE::CompositeStepAlgorithm< Real >::solveTangentialSubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::SimulatedConstraint< Real >::value(), ROL::AlmostSureConstraint< Real >::value(), ROL::RiskNeutralConstraint< Real >::value(), and ROL::InteriorPoint::PrimalDualResidual< Real >::value().
|
inlinevirtual |
Return i-th basis vector.
[in] | i | is the index of the basis function. |
Overloading the basis is only required if the default gradient implementation is used, which computes a finite-difference approximation.
Reimplemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ROL::RiskVector< Real >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::SimulatedVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::StdArray< Real, array_size, pool_size >, ROL::Vector_SimOpt< Real >, and ROL::SingletonVector< Real >.
Definition at line 148 of file ROL_Vector.hpp.
References ROL_UNUSED.
Referenced by ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::Constraint< Real >::checkApplyAdjointJacobian(), ROL::computeDenseHessian(), ROL::computeDotMatrix(), ROL::Objective< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::TypeE::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::initialize(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeE::StabilizedLCLAlgorithm< Real >::initialize(), ROL::AugmentedLagrangianStep< Real >::initialize(), and Objective_PoissonInversion< Real >::update().
|
inlinevirtual |
Return dimension of the vector space.
Overload if the basis is overloaded.
Reimplemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ROL::RiskVector< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::SimulatedVector< Real >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::Vector_SimOpt< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::SingletonVector< Real >, and ROL::BatchStdVector< Real >.
Definition at line 162 of file ROL_Vector.hpp.
Referenced by ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::StdVector< Real >::applyBinary(), ROL::StdVector< Real >::axpy(), ROL::Constraint< Real >::checkApplyAdjointJacobian(), ROL::computeDenseHessian(), ROL::computeDotMatrix(), ROL::BoundConstraint< Real >::computeInf(), ROL::computeScaledDenseHessian(), ROL::StdVector< Real >::dot(), ROL::DouglasRachfordProjection< Real >::DouglasRachfordProjection(), ROL::DykstraProjection< Real >::DykstraProjection(), ROL::Objective< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::RiddersProjection< Real >::initialize(), ROL::DaiFletcherProjection< Real >::initialize(), ROL::BrentsProjection< Real >::initialize(), ROL::TypeE::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::initialize(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeE::StabilizedLCLAlgorithm< Real >::initialize(), ROL::AugmentedLagrangianStep< Real >::initialize(), ROL::NullSpaceOperator< Real >::NullSpaceOperator(), ROL::details::VectorClone< Real >::operator()(), ROL::StdVector< Real >::plus(), ROL::LinMore< Real >::run(), ROL::SemismoothNewtonProjection< Real >::SemismoothNewtonProjection(), ROL::StdVector< Real >::set(), and ROL::Sketch< Real >::Sketch().
|
inlinevirtual |
Set \(y \leftarrow x\) where \(y = \mathtt{*this}\).
[in] | x | is a vector. |
On return \(\mathtt{*this} = x\). Uses zero and plus methods for the computation. Please overload if a more efficient implementation is needed.
Reimplemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::RiskVector< Real >, ROL::ElementwiseVector< Real >, ROL::SimulatedVector< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::SROMVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, and ROL::SingletonVector< Real >.
Definition at line 175 of file ROL_Vector.hpp.
References ROL::Vector< Real >::plus(), and ROL::Vector< Real >::zero().
Referenced by ROL::TypeE::CompositeStepAlgorithm< Real >::accept(), ROL::CompositeStep< Real >::accept(), ROL::Bundle_U< Real >::aggregate(), ROL::Bundle< Real >::aggregate(), ROL::IdentityOperator< Real >::apply(), Identity< Real >::apply(), ROL::DyadicOperator< Real >::apply(), ROL::DiagonalOperator< Real >::apply(), ROL::LinearOperatorProduct< Real >::apply(), ROL::NewtonKrylov_U< Real >::PrecondNK::apply(), ROL::HouseholderReflector< Real >::apply(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::HessianPNK::apply(), ROL::NewtonKrylovStep< Real >::PrecondNK::apply(), ROL::NullSpaceOperator< Real >::apply(), IdentityOperator< Real >::apply(), ROL::SemismoothNewtonProjection< Real >::Precond::apply(), ROL::FletcherObjectiveE< Real >::AugSystemPrecond::apply(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::PrecondPNK::apply(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::PrecondPDAS::apply(), ROL::ProjectedNewtonKrylovStep< Real >::PrecondPNK::apply(), ROL::Fletcher< Real >::AugSystemPrecond::apply(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::PrecondPDAS_Poly::apply(), ROL::PrimalDualActiveSetStep< Real >::PrecondPD::apply(), ROL::BoundFletcher< Real >::AugSystemPrecond::apply(), ROL::BinaryConstraint< Real >::applyAdjointHessian(), ROL::LowerBoundToConstraint< Real >::applyAdjointJacobian(), ROL::UpperBoundToConstraint< Real >::applyAdjointJacobian(), ROL::ScalarLinearConstraint< Real >::applyAdjointJacobian(), ROL::Secant< Real >::applyB0(), ROL::lSR1< Real >::applyB0(), ROL::ColemanLiModel< Real >::applyC(), ROL::ColemanLiModel< Real >::applyD(), ROL::TypeB::KelleySachsAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::LSecantBAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::LinMoreAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::KelleySachsAlgorithm< Real >::applyFreePrecond(), ROL::TypeB::LSecantBAlgorithm< Real >::applyFreePrecond(), ROL::TypeB::LinMoreAlgorithm< Real >::applyFreePrecond(), ROL::Secant< Real >::applyH0(), ROL::lSR1< Real >::applyH0(), ROL::IdentityOperator< Real >::applyInverse(), ROL::LinearOperatorFromConstraint< Real >::applyInverse(), ROL::DiagonalOperator< Real >::applyInverse(), ROL::LinearOperator< Real >::applyInverse(), ROL::LinearOperatorProduct< Real >::applyInverse(), TridiagonalToeplitzOperator< Real >::applyInverse(), ROL::SemismoothNewtonProjection< Real >::Precond::applyInverse(), ROL::ColemanLiModel< Real >::applyInverseD(), ROL::LowerBoundToConstraint< Real >::applyJacobian(), ROL::UpperBoundToConstraint< Real >::applyJacobian(), ROL::BinaryConstraint< Real >::applyJacobian(), ROL::Constraint< RealT >::applyPreconditioner(), ROL::Constraint_SimOpt< Real >::applyPreconditioner(), ROL::Bounds< Real >::buildScalingFunction(), ROL::Newton_U< Real >::compute(), ROL::Gradient_U< Real >::compute(), ROL::GradientStep< Real >::compute(), ROL::QuasiNewton_U< Real >::compute(), ROL::NonlinearCG_U< Real >::compute(), ROL::NewtonKrylov_U< Real >::compute(), ROL::BundleStep< Real >::compute(), ROL::NewtonKrylovStep< Real >::compute(), ROL::InteriorPointStep< Real >::compute(), ROL::ProjectedNewtonKrylovStep< Real >::compute(), ROL::MoreauYosidaPenaltyStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::AugmentedLagrangianStep< Real >::compute(), ROL::ColemanLiModel< Real >::computeFullReflectiveStep(), ROL::TypeP::TrustRegionAlgorithm< Real >::computeGradient(), ROL::TypeE::CompositeStepAlgorithm< Real >::computeQuasinormalStep(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::ColemanLiModel< Real >::computeReflectiveStep(), ROL::TypeP::TrustRegionAlgorithm< Real >::dbls(), ROL::LinMore< Real >::dbreakpt(), ROL::TypeB::LSecantBAlgorithm< Real >::dcauchy(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dcauchy(), ROL::TypeB::LinMoreAlgorithm< Real >::dcauchy(), ROL::TypeP::TrustRegionAlgorithm< Real >::dcauchy(), ROL::LinMore< Real >::dcauchy(), ROL::TypeB::LSecantBAlgorithm< Real >::dgpstep(), ROL::TypeB::ColemanLiAlgorithm< Real >::dgpstep(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dgpstep(), ROL::TypeB::LinMoreAlgorithm< Real >::dgpstep(), ROL::LinMore< Real >::dgpstep(), 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::LinMore< Real >::dprsrch(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg_simple(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::TypeB::LSecantBAlgorithm< Real >::dsrch(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::LinMore< Real >::dtrpcg(), ROL::TrustRegionModel< Real >::dualTransform(), ROL::KelleySachsModel< Real >::dualTransform(), ROL::VectorController< Real, Key >::get(), ROL::QuadraticPenalty< Real >::getConstraintVec(), ROL::QuadraticPenalty_SimOpt< Real >::getConstraintVec(), ROL::InteriorPoint::PenalizedObjective< Real >::getObjectiveGradient(), ROL::Objective_FSsolver< Real >::gradient(), ROL::ZOO::Objective_SumOfSquares< Real >::gradient(), ROL::LinearObjective< Real >::gradient(), ROL::LogBarrierObjective< Real >::gradient(), ROL::l1Objective< Real >::gradient(), ROL::ConicApproximationModel< Real >::gradient(), ROL::TypeP::InexactNewtonAlgorithm< Real >::NewtonObj::gradient(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::PH_ErrorObjective< Real >::gradient(), ROL::PH_RegretObjective< Real >::gradient(), ROL::PH_ProbObjective< Real >::gradient(), ROL::ObjectiveMMA< Real >::gradient(), ROL::AugmentedLagrangianObjective< Real >::gradient(), ROL::RiskNeutralObjective< Real >::gradient(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::ObjectiveFromBoundConstraint< Real >::gradient(), ROL::Fletcher< Real >::gradient(), ROL::InteriorPointObjective< Real >::gradient(), ROL::InteriorPointPenalty< Real >::gradient(), ROL::MoreauYosidaPenalty< Real >::gradient(), ROL::BoundFletcher< Real >::gradient(), ROL::LinearObjective_SimOpt< Real >::gradient_1(), ROL::AugmentedLagrangian_SimOpt< Real >::gradient_1(), ROL::LinearObjective_SimOpt< Real >::gradient_2(), ROL::AugmentedLagrangian_SimOpt< Real >::gradient_2(), ROL::DynamicTrackingObjective< Real >::gradient_un(), ROL::DynamicTrackingFEMObjective< Real >::gradient_un(), ROL::DynamicTrackingObjective< Real >::gradient_uo(), ROL::DynamicTrackingObjective< Real >::gradient_z(), ROL::DynamicTrackingFEMObjective< Real >::gradient_z(), ROL::Objective_FSsolver< Real >::hessVec(), ROL::LogBarrierObjective< Real >::hessVec(), ROL::ConicApproximationModel< Real >::hessVec(), ROL::ObjectiveMMA< Real >::hessVec(), ROL::ObjectiveFromBoundConstraint< Real >::hessVec(), ROL::BoundFletcher< Real >::hessVec(), ROL::DynamicTrackingObjective< Real >::hessVec_un_un(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_un_un(), ROL::DynamicTrackingObjective< Real >::hessVec_uo_uo(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_uo_uo(), ROL::DynamicTrackingObjective< Real >::hessVec_z_z(), ROL::DynamicTrackingFEMObjective< Real >::hessVec_z_z(), ROL::TypeP::SpectralGradientAlgorithm< Real >::initialize(), ROL::TypeP::iPianoAlgorithm< Real >::initialize(), ROL::TypeP::ProxGradientAlgorithm< Real >::initialize(), ROL::TypeP::QuasiNewtonAlgorithm< Real >::initialize(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::initialize(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::initialize(), ROL::TypeP::InexactNewtonAlgorithm< Real >::initialize(), ROL::TypeP::TrustRegionAlgorithm< Real >::initialize(), ROL::ZOO::Objective_SumOfSquares< Real >::invHessVec(), ROL::ConicApproximationModel< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), main(), ROL::TypeB::Algorithm< Real >::optimalityCriterion(), ROL::TypeP::Algorithm< Real >::pgstep(), ROL::ConicApproximationModel< Real >::precond(), ROL::Objective< Real >::precond(), ROL::Reduced_Objective_SimOpt< Real >::precond(), ROL::StochasticObjective< Real >::precond(), ROL::RiskNeutralObjective< Real >::precond(), ROL::TrustRegionModel< Real >::primalTransform(), ROL::KelleySachsModel< Real >::primalTransform(), ROL::ColemanLiModel< Real >::primalTransform(), ROL::DykstraProjection< Real >::project_bnd(), ROL::DouglasRachfordProjection< Real >::project_bnd(), ROL::DykstraProjection< Real >::project_con(), ROL::DouglasRachfordProjection< Real >::project_con(), ROL::RiddersProjection< Real >::project_df(), ROL::DaiFletcherProjection< Real >::project_df(), ROL::BrentsProjection< Real >::project_df(), ROL::DouglasRachfordProjection< Real >::project_DouglasRachford(), ROL::SemismoothNewtonProjection< Real >::project_ssn(), ROL::BallIndicatorObjective< Real >::prox(), ROL::l1Objective< Real >::prox(), ROL::TypeBIndicatorObjective< Real >::prox(), ROL::RandomizeFeasibleVector(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_hessVec(), ROL::TypeB::SpectralGradientAlgorithm< Real >::run(), ROL::TypeB::GradientAlgorithm< Real >::run(), ROL::DogLeg< Real >::run(), ROL::TypeP::ProxGradientAlgorithm< Real >::run(), ROL::TypeP::SpectralGradientAlgorithm< Real >::run(), ROL::TypeP::iPianoAlgorithm< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TypeE::FletcherAlgorithm< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::TypeB::LSecantBAlgorithm< Real >::run(), ROL::TypeB::KelleySachsAlgorithm< Real >::run(), ROL::TypeU::TrustRegionAlgorithm< Real >::run(), ROL::TypeB::ColemanLiAlgorithm< Real >::run(), ROL::TypeG::AugmentedLagrangianAlgorithm< Real >::run(), ROL::TypeE::StabilizedLCLAlgorithm< Real >::run(), ROL::TypeG::StabilizedLCLAlgorithm< Real >::run(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::run(), ROL::TypeB::LinMoreAlgorithm< Real >::run(), ROL::LinMore< Real >::run(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::run(), ROL::TypeP::TrustRegionAlgorithm< Real >::run(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::run(), BoundConstraint_BurgersControl< Real >::setVectorToLowerBound(), BoundConstraint_BurgersControl< Real >::setVectorToUpperBound(), 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::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::ZOO::Objective_PoissonInversion< Real >::solve_poisson(), ROL::ScalarLinearConstraint< Real >::solveAugmentedSystem(), ROL::FletcherObjectiveE< Real >::solveAugmentedSystem(), ROL::Fletcher< Real >::solveAugmentedSystem(), ROL::BoundFletcher< Real >::solveAugmentedSystem(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::TypeE::CompositeStepAlgorithm< Real >::solveTangentialSubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::BatchManager< Real >::sumAll(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::TrustRegion< Real >::update(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::BrentsProjection< Real >::update_primal(), ROL::RiddersProjection< Real >::update_primal(), ROL::DaiFletcherProjection< Real >::update_primal(), ROL::SemismoothNewtonProjection< Real >::update_primal(), ROL::LineSearch< Real >::updateIterate(), ROL::TypeB::MoreauYosidaAlgorithm< Real >::updateState(), ROL::TypeB::InteriorPointAlgorithm< Real >::updateState(), ROL::TypeG::MoreauYosidaAlgorithm< Real >::updateState(), ROL::TypeG::InteriorPointAlgorithm< Real >::updateState(), ROL::LowerBoundToConstraint< Real >::value(), ROL::UpperBoundToConstraint< Real >::value(), and ROL::BinaryConstraint< Real >::value().
|
inlinevirtual |
Return dual representation of \(\mathtt{*this}\), for example, the result of applying a Riesz map, or change of basis, or change of memory layout.
By default, returns the current object. Please overload if you need a dual representation.
Reimplemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, H1VectorDual< Real >, L2VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ROL::DualSimulatedVector< Real >, ConStdVector< Real, Element >, ROL::PrimalSimulatedVector< Real >, ConStdVector< Real, Element >, ROL::RiskVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::DualAtomVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::RieszDualVector< Real >, OptStdVector< Real, Element >, ROL::DualProbabilityVector< Real >, ROL::DualScaledStdVector< Real, Element >, ROL::SimulatedVector< Real >, ROL::PrimalAtomVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::PartitionedVector< Real >, ROL::PrimalProbabilityVector< Real >, ROL::SROMVector< Real >, ROL::RieszPrimalVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::PrimalScaledStdVector< Real, Element >.
Definition at line 192 of file ROL_Vector.hpp.
Referenced by ROL::CompositeStep< Real >::accept(), ROL::AffineTransformConstraint< Real >::AffineTransformConstraint(), ROL::AffineTransformObjective< Real >::AffineTransformObjective(), ROL::NewtonKrylov_U< Real >::PrecondNK::apply(), ROL::NewtonKrylovStep< Real >::PrecondNK::apply(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::HessianPNK::apply(), ROL::NullSpaceOperator< Real >::apply(), ROL::SemismoothNewtonProjection< Real >::Jacobian::apply(), ROL::SemismoothNewtonProjection< Real >::Precond::apply(), ROL::FletcherObjectiveE< Real >::AugSystemPrecond::apply(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::PrecondPNK::apply(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::PrecondPDAS::apply(), ROL::ProjectedNewtonKrylovStep< Real >::PrecondPNK::apply(), ROL::Fletcher< Real >::AugSystemPrecond::apply(), ROL::TypeB::PrimalDualActiveSetAlgorithm< Real >::PrecondPDAS_Poly::apply(), ROL::PrimalDualActiveSetStep< Real >::PrecondPD::apply(), ROL::Vector< Real >::apply(), ROL::BoundFletcher< Real >::AugSystemPrecond::apply(), ROL::RiskNeutralConstraint< Real >::applyAdjointHessian(), ROL::ElasticLinearConstraint< Real >::applyAdjointJacobian(), ROL::RiskNeutralConstraint< Real >::applyAdjointJacobian(), ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::lSR1< Real >::applyB(), ROL::Secant< Real >::applyB0(), ROL::lSR1< Real >::applyB0(), ROL::TypeB::KelleySachsAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::LSecantBAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::LinMoreAlgorithm< Real >::applyFreeHessian(), ROL::TypeB::KelleySachsAlgorithm< Real >::applyFreePrecond(), ROL::TypeB::LSecantBAlgorithm< Real >::applyFreePrecond(), ROL::TypeB::LinMoreAlgorithm< Real >::applyFreePrecond(), ROL::lSR1< Real >::applyH(), ROL::Secant< Real >::applyH0(), ROL::lSR1< Real >::applyH0(), ROL::TypeB::ColemanLiAlgorithm< Real >::applyHessian(), ROL::SemismoothNewtonProjection< Real >::Precond::applyInverse(), ROL::TypeB::NewtonKrylovAlgorithm< Real >::PrecondPNK::applyInverse(), ROL::ConstraintFromObjective< Real >::applyJacobian(), ROL::Constraint< RealT >::applyPreconditioner(), ROL::AugmentedLagrangian< Real >::AugmentedLagrangian(), ROL::AugmentedLagrangian_SimOpt< Real >::AugmentedLagrangian_SimOpt(), ROL::BoundFletcher< Real >::BoundFletcher(), ROL::DynamicConstraintCheck< Real >::check(), ROL::DynamicObjectiveCheck< Real >::check(), ROL::Constraint< RealT >::checkAdjointConsistencyJacobian(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_1(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_2(), ROL::Objective< Real >::checkGradient(), ROL::Objective_SimOpt< Real >::checkGradient_1(), ROL::Objective_SimOpt< Real >::checkGradient_2(), ROL::Objective< Real >::checkHessSym(), ROL::Objective< Real >::checkHessVec(), ROL::Objective_SimOpt< Real >::checkHessVec_11(), ROL::Objective_SimOpt< Real >::checkHessVec_12(), ROL::Objective_SimOpt< Real >::checkHessVec_21(), ROL::Objective_SimOpt< Real >::checkHessVec_22(), ROL::CompositeConstraint_SimOpt< Real >::CompositeConstraint_SimOpt(), ROL::Newton_U< Real >::compute(), ROL::Gradient_U< Real >::compute(), ROL::QuasiNewton_U< Real >::compute(), ROL::NonlinearCG_U< Real >::compute(), ROL::NewtonKrylov_U< Real >::compute(), ROL::TrustRegionStep< Real >::computeCriticalityMeasure(), ROL::computeDenseHessian(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), ROL::TypeP::TrustRegionAlgorithm< Real >::computeGradient(), ROL::FletcherStep< Real >::computeProjGradientNorm(), ROL::TypeE::CompositeStepAlgorithm< Real >::computeQuasinormalStep(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::computeScaledDenseHessian(), ROL::LinMore< Real >::dcauchy(), ROL::Objective< Real >::dirDeriv(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::LinMore< Real >::dprsrch(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg_simple(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::LinMore< Real >::dtrpcg(), ROL::Fletcher< Real >::Fletcher(), ROL::PH_bPOEObjective< Real >::getGradient(), ROL::PH_DeviationObjective< Real >::getGradient(), ROL::PH_ErrorObjective< Real >::getGradient(), ROL::PH_ProbObjective< Real >::getGradient(), ROL::PH_RiskObjective< Real >::getGradient(), ROL::PH_RegretObjective< Real >::getGradient(), ROL::InteriorPointObjective< Real >::getObjectiveGradient(), ROL::LineSearchStep< Real >::GradDotStep(), ROL::Objective_FSsolver< Real >::gradient(), ROL::Objective_FSsolver< Real >::hessVec(), ROL::NonlinearLeastSquaresObjective< Real >::hessVec(), ROL::PH_Objective< Real >::hessVec(), ROL::FletcherObjectiveE< Real >::hessVec(), ROL::RiskNeutralConstraint< Real >::init(), ROL::RiskNeutralObjective< Real >::initialize(), ROL::CompositeObjective_SimOpt< Real >::initialize(), ROL::TrustRegionModel< Real >::initialize(), ROL::CompositeObjective< Real >::initialize(), ROL::BPOE< Real >::initialize(), ROL::MoreauYosidaPenalty< Real >::initialize(), ROL::KLDivergence< Real >::initialize(), ROL::HMCR< Real >::initialize(), ROL::MeanDeviationFromTarget< Real >::initialize(), ROL::RandVarFunctional< Real >::initialize(), ROL::TRUtils::initialRadius(), main(), ROL::ColemanLiModel< Real >::minimize1D(), ROL::NonlinearLeastSquaresObjective< Real >::NonlinearLeastSquaresObjective(), ROL::NonlinearLeastSquaresObjective_Dynamic< Real >::NonlinearLeastSquaresObjective_Dynamic(), ROL::NullSpaceOperator< Real >::NullSpaceOperator(), ROL::TypeB::Algorithm< Real >::optimalityCriterion(), ROL::InteriorPoint::PenalizedObjective< Real >::PenalizedObjective(), ROL::NonlinearLeastSquaresObjective< Real >::precond(), ROL::Objective< Real >::precond(), ROL::Reduced_Objective_SimOpt< Real >::precond(), ROL::StochasticObjective< Real >::precond(), ROL::RiskNeutralObjective< Real >::precond(), ROL::QuadraticPenalty< Real >::QuadraticPenalty(), ROL::QuadraticPenalty_SimOpt< Real >::QuadraticPenalty_SimOpt(), ROL::ProjectedObjective< Real >::reducedHessVec(), ROL::ProjectedObjective< Real >::reducedInvHessVec(), ROL::ProjectedObjective< Real >::reducedPrecond(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::Algorithm< Real >::run(), ROL::TypeB::LSecantBAlgorithm< Real >::run(), ROL::TypeU::Algorithm< Real >::run(), ROL::TypeB::Algorithm< Real >::run(), ROL::TypeP::Algorithm< Real >::run(), ROL::TypeB::LinMoreAlgorithm< Real >::run(), ROL::DoubleDogLeg_U< Real >::solve(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::ScalarLinearConstraint< Real >::solveAugmentedSystem(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::TypeE::CompositeStepAlgorithm< Real >::solveTangentialSubproblem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::TrustRegion< Real >::update(), ROL::Bundle< Real >::update(), ROL::TrustRegionModel< Real >::value(), ROL::KelleySachsModel< Real >::value(), and ROL::ColemanLiModel< Real >::value().
|
inlinevirtual |
Apply \(\mathtt{*this}\) to a dual vector. This is equivalent to the call \(\mathtt{this->dot(x.dual())}\).
[in] | x | is a vector |
Reimplemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::ProfiledVector< Ordinal, Real >, ROL::DualScaledStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::PrimalScaledStdVector< Real, Element >, and ROL::Vector_SimOpt< Real >.
Definition at line 204 of file ROL_Vector.hpp.
References ROL::Vector< Real >::dot(), and ROL::Vector< Real >::dual().
Referenced by ROL::TypeE::CompositeStepAlgorithm< Real >::accept(), ROL::ConstraintFromObjective< Real >::applyJacobian(), ROL::Constraint< Real >::checkAdjointConsistencyJacobian(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_1(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_2(), ROL::Objective< Real >::checkGradient(), ROL::Objective_SimOpt< Real >::checkGradient_1(), ROL::Objective_SimOpt< Real >::checkGradient_2(), ROL::Objective< Real >::checkHessSym(), ROL::Newton_U< Real >::compute(), ROL::Gradient_U< Real >::compute(), ROL::QuasiNewton_U< Real >::compute(), ROL::NonlinearCG_U< Real >::compute(), ROL::NewtonKrylov_U< Real >::compute(), ROL::RandVarFunctional< Real >::computeGradVec(), ROL::TypeB::LSecantBAlgorithm< Real >::dcauchy(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dcauchy(), ROL::TypeB::LinMoreAlgorithm< Real >::dcauchy(), ROL::TypeP::TrustRegionAlgorithm< Real >::dcauchy(), ROL::Objective< Real >::dirDeriv(), ROL::TypeP::TrustRegionAlgorithm< Real >::dncg(), ROL::TypeB::LSecantBAlgorithm< Real >::dpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dprsrch(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg(), ROL::TypeB::TrustRegionSPGAlgorithm< Real >::dpsg_simple(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg(), ROL::TypeP::TrustRegionAlgorithm< Real >::dspg2(), ROL::TypeB::ColemanLiAlgorithm< Real >::dtrpcg(), ROL::TypeB::LinMoreAlgorithm< Real >::dtrpcg(), ROL::PH_RegretObjective< Real >::hessVec(), ROL::PH_ErrorObjective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::TRUtils::interpolateRadius(), ROL::SemismoothNewtonProjection< Real >::project_ssn(), ROL::TypeB::KelleySachsAlgorithm< Real >::trpcg(), ROL::lSR1< Real >::updateStorage(), ROL::Secant< Real >::updateStorage(), ROL::LinearObjective_SimOpt< Real >::value(), and ROL::QuadraticObjective< Real >::value().
|
inlinevirtual |
Reimplemented in ROL::RiskVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::SimulatedVector< Real >, ROL::RieszDualVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::SROMVector< Real >, ROL::Vector_SimOpt< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::RieszPrimalVector< Real >, ROL::SingletonVector< Real >, and ROL::ElementwiseVector< Real >.
Definition at line 208 of file ROL_Vector.hpp.
References ROL_UNUSED.
Referenced by calcError(), ROL::LogBarrierObjective< Real >::gradient(), ROL::l1Objective< Real >::gradient(), ROL::Vector< Real >::randomize(), ROL::RandomizeFeasibleVector(), ROL::RandomizeVector(), ROL::Vector< Real >::setScalar(), and testRandomInputs().
|
inlinevirtual |
Reimplemented in ROL::RiskVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::SimulatedVector< Real >, ROL::RieszDualVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::SROMVector< Real >, ROL::Vector_SimOpt< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::RieszPrimalVector< Real >, ROL::SingletonVector< Real >, and ROL::ElementwiseVector< Real >.
Definition at line 214 of file ROL_Vector.hpp.
References ROL_UNUSED.
Referenced by ROL::DiagonalOperator< Real >::apply(), ROL::BinaryConstraint< Real >::applyAdjointHessian(), ROL::ColemanLiModel< Real >::applyC(), ROL::ColemanLiModel< Real >::applyD(), ROL::DiagonalOperator< Real >::applyInverse(), ROL::ColemanLiModel< Real >::applyInverseD(), ROL::Bounds< Real >::applyInverseScalingFunction(), ROL::BinaryConstraint< Real >::applyJacobian(), ROL::Bounds< Real >::applyScalingFunctionJacobian(), ROL::Bounds< Real >::buildScalingFunction(), ROL::ColemanLiModel< Real >::computeFullReflectiveStep(), ROL::ColemanLiModel< Real >::computeReflectiveStep(), ROL::LinMore< Real >::dbreakpt(), ROL::l1Objective< Real >::gradient(), ROL::LogBarrierObjective< Real >::hessVec(), ROL::ObjectiveMMA< Real >::hessVec(), ROL::ObjectiveFromBoundConstraint< Real >::hessVec(), ROL::Bounds< Real >::project(), ROL::Bounds< Real >::projectInterior(), ROL::l1Objective< Real >::prox(), ROL::Bounds< Real >::pruneLowerActive(), ROL::Bounds< Real >::pruneUpperActive(), testRandomInputs(), and ROL::BinaryConstraint< Real >::value().
|
inlinevirtual |
Reimplemented in ROL::RiskVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::SimulatedVector< Real >, ROL::RieszDualVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::Vector_SimOpt< Real >, ROL::SROMVector< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::RieszPrimalVector< Real >, ROL::SingletonVector< Real >, ROL::ElementwiseVector< Real >, and ROL::BatchStdVector< Real >.
Definition at line 221 of file ROL_Vector.hpp.
References ROL_UNUSED.
Referenced by calcError(), and ROL::LinMore< Real >::dbreakpt().
|
inlinevirtual |
Reimplemented in ROL::ProfiledVector< Ordinal, Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::Vector_SimOpt< Real >, ROL::StdArray< Real, array_size, pool_size >, and ROL::SingletonVector< Real >.
Definition at line 227 of file ROL_Vector.hpp.
Referenced by ROL::Algorithm< Real >::run(), and ROL::ReducedDynamicObjective< Real >::update().
|
inlinevirtual |
Set \(y \leftarrow C\) where \(C\in\mathbb{R}\).
[in] | C | is a scalar. |
On return \(\mathtt{*this} = C\). Uses applyUnary methods for the computation. Please overload if a more efficient implementation is needed.
Reimplemented in ROL::RiskVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::SimulatedVector< Real >, ROL::RieszDualVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::Vector_SimOpt< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::RieszPrimalVector< Real >, and ROL::SingletonVector< Real >.
Definition at line 241 of file ROL_Vector.hpp.
References ROL::Vector< Real >::applyUnary().
Referenced by ROL::Bounds< Real >::applyScalingFunctionJacobian(), and ROL::Bounds< Real >::buildScalingFunction().
|
inlinevirtual |
Set vector to be uniform random between [l,u].
[in] | l | is a the lower bound. |
[in] | u | is a the upper bound. |
On return the components of \(\mathtt{*this}\) are uniform random numbers on the interval \([l,u]\). The default implementation uses applyUnary methods for the computation. Please overload if a more efficient implementation is needed.
Reimplemented in ROL::RiskVector< Real >, ROL::SimulatedVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::PartitionedVector< Real >, ROL::RieszDualVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::Vector_SimOpt< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::RieszPrimalVector< Real >, and ROL::SingletonVector< Real >.
Definition at line 258 of file ROL_Vector.hpp.
References ROL::Vector< Real >::applyUnary().
|
inlinevirtual |
Verify vector-space methods.
[in] | x | is a vector. |
[in] | y | is a vector. |
Returns a vector of Reals, all of which should be close to zero. They represent consistency errors in the vector space properties, as follows:
The consistency errors are defined as the norms or absolute values of the differences between the left-hand side and the right-hand side terms in the above equalities.
Definition at line 291 of file ROL_Vector.hpp.
References ROL::Vector< Real >::clone(), and ROL::Vector< Real >::zero().
Referenced by ROL::OptimizationProblem< Real >::checkMultiplierVector(), ROL::OptimizationProblem< Real >::checkSolutionVector(), and main().