ROL
Public Member Functions | List of all members
ROL::Vector< Real > Class Template Referenceabstract

Defines the linear algebra or vector space interface. More...

#include <ROL_Vector.hpp>

+ Inheritance diagram for ROL::Vector< Real >:

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< Vectorclone () 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< Vectorbasis (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 Vectordual () 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 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...
 

Detailed Description

template<class Real>
class ROL::Vector< Real >

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 80 of file ROL_Vector.hpp.

Constructor & Destructor Documentation

template<class Real>
virtual ROL::Vector< Real >::~Vector ( )
inlinevirtual

Definition at line 87 of file ROL_Vector.hpp.

Member Function Documentation

template<class Real>
virtual void ROL::Vector< Real >::plus ( const Vector< Real > &  x)
pure virtual

Compute \(y \leftarrow y + x\), where \(y = \mathtt{*this}\).

Parameters
[in]xis the vector to be added to \(\mathtt{*this}\).

On return \(\mathtt{*this} = \mathtt{*this} + x\).


Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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 >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::SimulatedVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::PartitionedVector< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::ElementwiseVector< Real >.

Referenced by 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::Reduced_Constraint_SimOpt< Real >::applyAdjointHessian(), ROL::CompositeConstraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::BoundToConstraint< Real >::applyAdjointJacobian(), ROL::Reduced_Constraint_SimOpt< Real >::applyAdjointJacobian(), ROL::ProjectedNewtonKrylovStep< Real >::PrecondPNK::applyInverse(), ROL::Reduced_Constraint_SimOpt< Real >::applyJacobian(), ROL::Constraint_SimOpt< Real >::applyJacobian(), ROL::Vector< Real >::axpy(), ROL::ProjectedNewtonStep< Real >::compute(), ROL::ProjectedSecantStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::PrimalDualActiveSetStep< Real >::compute(), 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::LinMore< Real >::dprsrch(), ROL::LinMore< Real >::dtrpcg(), ROL::MeanVariance< Real >::getGradient(), ROL::PD_MeanSemiDeviation< Real >::getHessVec(), ROL::MeanVariance< Real >::getHessVec(), ROL::QuadraticObjective< Real >::gradient(), ROL::ConicApproximationModel< Real >::gradient(), ROL::InteriorPoint::PenalizedObjective< Real >::gradient(), ROL::PH_Objective< Real >::gradient(), ROL::TrustRegionModel< Real >::gradient(), ROL::ObjectiveMMA< Real >::gradient(), ROL::KelleySachsModel< Real >::gradient(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::ColemanLiModel< Real >::gradient(), ROL::Reduced_Objective_SimOpt< 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_SimOpt< Real >::hessVec(), ROL::NonlinearLeastSquaresObjective_Dynamic< Real >::hessVec(), ROL::InteriorPoint::PenalizedObjective< Real >::hessVec(), ROL::QuadraticPenalty< Real >::hessVec(), ROL::ObjectiveMMA< Real >::hessVec(), ROL::KelleySachsModel< Real >::hessVec(), ROL::AugmentedLagrangian< Real >::hessVec(), ROL::ColemanLiModel< Real >::hessVec(), ROL::Fletcher< Real >::hessVec(), ROL::Reduced_Objective_SimOpt< 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::RandomizeFeasibleVector(), ROL::ProjectedObjective< Real >::reducedHessVec(), ROL::ProjectedObjective< Real >::reducedInvHessVec(), ROL::ProjectedObjective< Real >::reducedPrecond(), ROL::GMRES< Real >::run(), ROL::Vector< Real >::set(), ROL::RangeSpaceOperator< Real >::solveAugmentedSystem(), ROL::NullSpaceOperator< Real >::solveAugmentedSystem(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::Fletcher< Real >::solveAugmentedSystem(), ROL::BoundFletcher< Real >::solveAugmentedSystem(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), 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::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(), and ROL::PrimalDualActiveSetStep< Real >::update().

template<class Real>
virtual void ROL::Vector< Real >::scale ( const Real  alpha)
pure virtual

Compute \(y \leftarrow \alpha y\) where \(y = \mathtt{*this}\).

Parameters
[in]alphais the scaling of \(\mathtt{*this}\).

On return \(\mathtt{*this} = \alpha (\mathtt{*this}) \).


Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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 >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::SimulatedVector< Real >, OptStdVector< Real, Element >, ROL::PartitionedVector< Real >, ROL::StdArray< Real, array_size, pool_size >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::ElementwiseVector< Real >.

Referenced by ROL::DyadicOperator< Real >::apply(), ROL::Constraint< Real >::applyAdjointHessian(), ROL::BinaryConstraint< 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::ScalarLinearConstraint< Real >::applyAdjointJacobian(), ROL::ConstraintFromObjective< Real >::applyAdjointJacobian(), ROL::CompositeConstraint_SimOpt< Real >::applyAdjointSens(), ROL::BarzilaiBorwein< Real >::applyB(), ROL::lDFP< Real >::applyB0(), ROL::Secant< Real >::applyB0(), ROL::BarzilaiBorwein< Real >::applyH(), ROL::lDFP< Real >::applyH0(), ROL::Secant< Real >::applyH0(), ROL::UpperBoundToConstraint< Real >::applyJacobian(), ROL::Constraint< Real >::applyJacobian(), ROL::BinaryConstraint< Real >::applyJacobian(), ROL::Constraint_SimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_2(), ROL::CompositeConstraint_SimOpt< Real >::applySens(), ROL::CauchyPoint< Real >::cauchypoint_unc(), ROL::NewtonStep< Real >::compute(), ROL::GradientStep< Real >::compute(), ROL::ProjectedNewtonStep< Real >::compute(), ROL::NonlinearCGStep< Real >::compute(), ROL::ProjectedSecantStep< Real >::compute(), ROL::SecantStep< 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::CompositeStep< Real >::computeQuasinormalStep(), ROL::LinMore< Real >::dcauchy(), 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::LogBarrierObjective< Real >::gradient(), ROL::ZOO::Objective_SumOfSquares< 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::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::ZOO::Objective_HS24< Real >::hessVec(), ROL::ConicApproximationModel< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::PH_RegretObjective< Real >::hessVec(), ROL::PH_ErrorObjective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::QuadraticPenalty< 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::ZOO::Objective_SumOfSquares< Real >::invHessVec(), ROL::ConicApproximationModel< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), ROL::ConicApproximationModel< Real >::precond(), ROL::ColemanLiModel< Real >::primalTransform(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_hessVec(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::BinaryConstraint< Real >::value(), and ROL::Vector< Real >::zero().

template<class Real>
virtual Real ROL::Vector< Real >::dot ( const Vector< Real > &  x) const
pure virtual

Compute \( \langle y,x \rangle \) where \(y = \mathtt{*this}\).

Parameters
[in]xis the vector that forms the dot product with \(\mathtt{*this}\).
Returns
The number equal to \(\langle \mathtt{*this}, x \rangle\).

Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, H1VectorPrimal< 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 >, ROL::RieszDualVector< Real >, OptDualStdVector< Real, Element >, ROL::DualAtomVector< Real >, OptDualStdVector< Real, Element >, 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 >, ROL::PrimalProbabilityVector< Real >, OptStdVector< Real, Element >, ROL::RieszPrimalVector< Real >, OptStdVector< Real, Element >, ROL::StdArray< Real, array_size, pool_size >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, ROL::PrimalScaledStdVector< Real, Element >, ROL::ElementwiseVector< Real >, and ROL::BatchStdVector< Real >.

Referenced by ROL::CompositeStep< Real >::accept(), ROL::Sketch< Real >::advance(), ROL::DyadicOperator< Real >::apply(), ROL::NullSpaceOperator< Real >::apply(), ROL::lBFGS< Real >::applyB(), ROL::lBFGS< Real >::applyH(), 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::BundleStep< Real >::compute(), ROL::RandVarFunctional< Real >::computeGradVec(), ROL::LinMore< Real >::dcauchy(), ROL::ZOO::Objective_Zakharov< Real >::dirDeriv(), ROL::Bundle< Real >::dotGi(), ROL::LinMore< Real >::dprsrch(), 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::PH_ErrorObjective< Real >::hessVec(), ROL::PH_RegretObjective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), ROL::DoubleDogLeg< Real >::run(), ROL::LinMore< Real >::run(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::LineSearch< Real >::status(), ROL::TrustRegion< Real >::update(), ROL::lSR1< Real >::updateStorage(), ROL::Secant< Real >::updateStorage(), ROL::Objective_FSsolver< Real >::value(), ROL::ZOO::Objective_SumOfSquares< Real >::value(), ROL::LinearObjective_SimOpt< Real >::value(), ROL::LinearObjective< Real >::value(), ROL::QuadraticObjective< Real >::value(), ROL::DynamicTrackingObjective< Real >::value(), ROL::DynamicTrackingFEMObjective< Real >::value(), ROL::ZOO::Objective_Zakharov< Real >::value(), and ROL::PH_Objective< Real >::value().

template<class Real>
virtual Real ROL::Vector< Real >::norm ( ) const
pure virtual

Returns \( \| y \| \) where \(y = \mathtt{*this}\).

Returns
A nonnegative number equal to the norm of \(\mathtt{*this}\).

Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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 >, 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 >, ROL::StdArray< Real, array_size, pool_size >, ROL::SROMVector< Real >, ROL::SingletonVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::ElementwiseVector< Real >.

Referenced by 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::CauchyPoint< Real >::cauchypoint_unc(), 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::PrimalDualActiveSetStep< Real >::compute(), ROL::TrustRegionStep< Real >::computeCriticalityMeasure(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), ROL::FletcherStep< Real >::computeProjGradientNorm(), ROL::LinMore< Real >::dbreakpt(), ROL::LinMore< Real >::dgpstep(), ROL::Objective< Real >::dirDeriv(), 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::Sketch< Real >::reconstruct(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::LinMore< Real >::run(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), Constraint_BurgersControl< Real >::solve(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), 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::NewtonKrylovStep< Real >::update(), ROL::ProjectedNewtonKrylovStep< Real >::update(), ROL::InteriorPointStep< Real >::update(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::AugmentedLagrangianStep< Real >::update(), and ROL::PrimalDualActiveSetStep< Real >::update().

template<class Real>
virtual ROL::Ptr<Vector> ROL::Vector< Real >::clone ( ) const
pure virtual

Clone to make a new (uninitialized) vector.

Returns
A reference-counted pointer to the cloned vector.

Provides the means of allocating temporary memory in ROL.


Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, H1VectorPrimal< 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 >, ROL::DualAtomVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::RieszDualVector< Real >, ROL::DualProbabilityVector< Real >, ROL::ProfiledVector< Ordinal, Real >, OptStdVector< Real, Element >, ROL::SimulatedVector< Real >, ROL::DualScaledStdVector< Real, Element >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::PrimalAtomVector< Real >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, ROL::PrimalProbabilityVector< Real >, 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::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::lBFGS< Real >::applyB(), ROL::lDFP< Real >::applyB(), ROL::lSR1< Real >::applyB(), ROL::lDFP< Real >::applyH(), ROL::lBFGS< Real >::applyH(), ROL::lSR1< Real >::applyH(), 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_State< Real >::applyPreconditioner(), ROL::Constraint_DynamicState< Real >::applyPreconditioner(), ROL::Vector< Real >::axpy(), ROL::BoundConstraint< Real >::BoundConstraint(), ROL::BoundFletcher< Real >::BoundFletcher(), ROL::BoundToConstraint< Real >::BoundToConstraint(), ROL::DynamicObjectiveCheck< Real >::check(), ROL::DynamicConstraintCheck< 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::Fletcher< Real >::Fletcher(), ROL::RiskNeutralObjective< Real >::getGradient(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::Objective< Real >::gradient(), Objective_GrossPitaevskii< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::LinearCombinationObjective_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::IterationScaling< Real >::initialize(), ROL::BackTracking< Real >::initialize(), ROL::CubicInterp< Real >::initialize(), ROL::GoldenSection< Real >::initialize(), ROL::Bisection< Real >::initialize(), ROL::DogLeg< Real >::initialize(), ROL::DoubleDogLeg< Real >::initialize(), ROL::PathBasedTargetLevel< Real >::initialize(), ROL::Brents< Real >::initialize(), ROL::Bundle_AS< Real >::initialize(), ROL::CauchyPoint< Real >::initialize(), ROL::TruncatedCG< Real >::initialize(), ROL::ProjectedNewtonStep< Real >::initialize(), ROL::Step< Real >::initialize(), ROL::ProjectedSecantStep< Real >::initialize(), ROL::SecantStep< Real >::initialize(), ROL::LineSearch< Real >::initialize(), ROL::TrustRegion< Real >::initialize(), ROL::MoreauYosidaPenalty< Real >::initialize(), ROL::LinMore< Real >::initialize(), ROL::Bundle< 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::ScalarMinimizationLineSearch< Real >::initialize(), ROL::ProjectedNewtonKrylovStep< Real >::initialize(), ROL::AugmentedLagrangianStep< Real >::initialize(), ROL::PrimalDualActiveSetStep< Real >::initialize(), ROL::TrustRegionStep< Real >::initialize(), ROL::KelleySachsModel< Real >::KelleySachsModel(), ROL::LinMoreModel< Real >::LinMoreModel(), ROL::LowerBoundToConstraint< Real >::LowerBoundToConstraint(), ROL::NonlinearLeastSquaresObjective< Real >::NonlinearLeastSquaresObjective(), ROL::NonlinearLeastSquaresObjective_Dynamic< Real >::NonlinearLeastSquaresObjective_Dynamic(), ROL::NonlinearLeastSquaresObjective_SimOpt< Real >::NonlinearLeastSquaresObjective_SimOpt(), ROL::normL1(), ROL::normLinf(), ROL::normLp(), ROL::ObjectiveMMA< Real >::ObjectiveMMA(), ROL::details::VectorClone< Real >::operator()(), ROL::InteriorPoint::PenalizedObjective< Real >::PenalizedObjective(), ROL::PH_StatusTest< Real >::PH_StatusTest(), 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::GMRES< Real >::run(), ROL::Algorithm< Real >::run(), ROL::SampledVector< Real, Key >::set(), ROL::SimController< Real, Key >::set(), ROL::Sketch< Real >::Sketch(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::Secant< Real >::test(), Objective_PoissonInversion< Real >::update(), ROL::lSR1< Real >::updateStorage(), ROL::Secant< Real >::updateStorage(), ROL::UpperBoundToConstraint< Real >::UpperBoundToConstraint(), ROL::LogBarrierObjective< Real >::value(), Objective_GrossPitaevskii< Real >::value(), and CLExactModel< Real >::value().

template<class Real>
virtual void ROL::Vector< Real >::axpy ( const Real  alpha,
const Vector< Real > &  x 
)
inlinevirtual

Compute \(y \leftarrow \alpha x + y\) where \(y = \mathtt{*this}\).

Parameters
[in]alphais the scaling of x.
[in]xis 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 153 of file ROL_Vector.hpp.

References ROL::Vector< Real >::clone(), and ROL::Vector< Real >::plus().

Referenced by ROL::Bundle< Real >::addGi(), ROL::ReducedDynamicObjective< Real >::addMixedHessLag(), ROL::BlockOperator2Determinant< Real >::apply(), ROL::HouseholderReflector< Real >::apply(), ROL::NullSpaceOperator< Real >::apply(), ROL::Constraint< Real >::applyAdjointHessian(), ROL::BinaryConstraint< 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::lBFGS< Real >::applyB(), ROL::lDFP< Real >::applyB(), ROL::lSR1< Real >::applyB(), ROL::lBFGS< Real >::applyH(), ROL::lDFP< Real >::applyH(), ROL::lSR1< Real >::applyH(), ROL::Constraint< Real >::applyJacobian(), ROL::BinaryConstraint< Real >::applyJacobian(), ROL::Constraint_TimeSimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_1(), ROL::Constraint_SimOpt< Real >::applyJacobian_2(), 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::CompositeStep< Real >::computeQuasinormalStep(), ROL::LinMore< Real >::dbreakpt(), ROL::LinMore< Real >::dgpstep(), 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::ZOO::Objective_Zakharov< Real >::gradient(), ROL::Objective< Real >::gradient(), ROL::CompositeObjective< Real >::gradient(), ROL::InteriorPointPenalty< Real >::gradient(), ROL::MoreauYosidaPenalty< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::LinearCombinationObjective_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::ConicApproximationModel< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::PH_ErrorObjective< Real >::hessVec(), ROL::PH_RegretObjective< Real >::hessVec(), ROL::PH_Objective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::CompositeObjective< Real >::hessVec(), ROL::Fletcher< Real >::hessVec(), ROL::MoreauYosidaPenalty< Real >::hessVec(), ROL::InteriorPointPenalty< 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::ConicApproximationModel< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), main(), ROL::ConicApproximationModel< Real >::precond(), ROL::KelleySachsModel< Real >::primalTransform(), 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::details::MINRES< Real >::run(), ROL::LinMore< Real >::run(), ROL::RangeSpaceOperator< Real >::solveAugmentedSystem(), ROL::NullSpaceOperator< Real >::solveAugmentedSystem(), ROL::ScalarLinearConstraint< Real >::solveAugmentedSystem(), ROL::AugmentedLagrangianStep< Real >::update(), ROL::ReducedDynamicObjective< Real >::updateGradient(), ROL::LineSearch< Real >::updateIterate(), ROL::UpperBoundToConstraint< Real >::value(), ROL::LowerBoundToConstraint< Real >::value(), and ROL::BinaryConstraint< Real >::value().

template<class Real>
virtual void ROL::Vector< Real >::zero ( )
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::ProfiledVector< Ordinal, Real >, ROL::PartitionedVector< Real >, ROL::StdArray< Real, array_size, pool_size >, and ROL::ElementwiseVector< Real >.

Definition at line 167 of file ROL_Vector.hpp.

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

Referenced by ROL::Bundle< Real >::aggregate(), ROL::NullOperator< Real >::apply(), ROL::LowerBoundToConstraint< Real >::applyAdjointHessian(), ROL::UpperBoundToConstraint< Real >::applyAdjointHessian(), ROL::BoundToConstraint< Real >::applyAdjointHessian(), ROL::LinearConstraint< 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::LinMore< Real >::dtrpcg(), ROL::BPOE< Real >::getGradient(), NullObjective< Real >::gradient(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::SimulatedObjective< Real >::gradient(), ROL::ZOO::Objective_BVP< Real >::gradient(), ROL::ZOO::Objective_HS25< Real >::gradient(), ROL::SimulatedObjectiveCVaR< Real >::gradient(), ROL::Objective< Real >::gradient(), ROL::PH_ProbObjective< Real >::gradient(), ROL::CompositeObjective< 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::Objective_SimOpt< Real >::gradient_1(), ROL::LinearCombinationObjective_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(), NullObjective< Real >::hessVec(), ROL::LinearObjective< Real >::hessVec(), ROL::ZOO::Objective_HS39< Real >::hessVec(), ROL::LinearCombinationObjective< Real >::hessVec(), ROL::SimulatedObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::PH_ProbObjective< Real >::hessVec(), ROL::CompositeObjective< Real >::hessVec(), ROL::QuadraticPenalty< Real >::hessVec(), ROL::StochasticObjective< Real >::hessVec(), ROL::MomentObjective< 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::CompositeObjective_SimOpt< Real >::hessVec_21(), ROL::QuadraticPenalty_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::GMRES< Real >::run(), ROL::Vector< Real >::set(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::SimulatedConstraint< Real >::value(), ROL::AlmostSureConstraint< Real >::value(), ROL::RiskNeutralConstraint< Real >::value(), and ROL::InteriorPoint::PrimalDualResidual< Real >::value().

template<class Real>
virtual ROL::Ptr<Vector> ROL::Vector< Real >::basis ( const int  i) const
inlinevirtual

Return i-th basis vector.

Parameters
[in]iis the index of the basis function.
Returns
A reference-counted pointer to the basis vector with index i.

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 >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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 >, 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 >, ROL::StdArray< Real, array_size, pool_size >, ROL::Vector_SimOpt< Real >, and ROL::SingletonVector< Real >.

Definition at line 182 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::AugmentedLagrangianStep< Real >::initialize(), and Objective_PoissonInversion< Real >::update().

template<class Real>
virtual int ROL::Vector< Real >::dimension ( void  ) const
inlinevirtual

Return dimension of the vector space.

Returns
The dimension of the vector space, i.e., the total number of basis vectors.

Overload if the basis is overloaded.


Reimplemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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 >, 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 >, ROL::SROMVector< Real >, ROL::StdArray< Real, array_size, pool_size >, ROL::SingletonVector< Real >, and ROL::BatchStdVector< Real >.

Definition at line 196 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::computeScaledDenseHessian(), ROL::StdVector< Real >::dot(), ROL::Objective< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::AugmentedLagrangianStep< Real >::initialize(), ROL::details::VectorClone< Real >::operator()(), ROL::StdVector< Real >::plus(), ROL::LinMore< Real >::run(), ROL::StdVector< Real >::set(), and ROL::Sketch< Real >::Sketch().

template<class Real>
virtual void ROL::Vector< Real >::set ( const Vector< Real > &  x)
inlinevirtual

Set \(y \leftarrow x\) where \(y = \mathtt{*this}\).

Parameters
[in]xis 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 >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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::SingletonVector< Real >, ROL::StdVector< Real, Element >, and ROL::StdVector< Real >.

Definition at line 209 of file ROL_Vector.hpp.

References ROL::Vector< Real >::plus(), and ROL::Vector< Real >::zero().

Referenced by ROL::CompositeStep< Real >::accept(), ROL::Bundle< Real >::aggregate(), ROL::IdentityOperator< Real >::apply(), Identity< Real >::apply(), ROL::DyadicOperator< Real >::apply(), ROL::DiagonalOperator< Real >::apply(), ROL::LinearOperatorProduct< Real >::apply(), ROL::HouseholderReflector< Real >::apply(), ROL::NewtonKrylovStep< Real >::PrecondNK::apply(), IdentityOperator< Real >::apply(), ROL::ProjectedNewtonKrylovStep< Real >::PrecondPNK::apply(), ROL::Fletcher< Real >::AugSystemPrecond::apply(), ROL::NullSpaceOperator< Real >::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::BarzilaiBorwein< Real >::applyB(), ROL::lDFP< Real >::applyB(), ROL::lDFP< Real >::applyB0(), ROL::Secant< Real >::applyB0(), ROL::lSR1< Real >::applyB0(), ROL::ColemanLiModel< Real >::applyC(), ROL::ColemanLiModel< Real >::applyD(), ROL::lBFGS< Real >::applyH(), ROL::BarzilaiBorwein< Real >::applyH(), ROL::lDFP< Real >::applyH0(), ROL::lSR1< Real >::applyH0(), ROL::Secant< 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::ColemanLiModel< Real >::applyInverseD(), ROL::UpperBoundToConstraint< Real >::applyJacobian(), ROL::LowerBoundToConstraint< Real >::applyJacobian(), ROL::BinaryConstraint< Real >::applyJacobian(), ROL::Constraint< Real >::applyPreconditioner(), ROL::Constraint_SimOpt< Real >::applyPreconditioner(), ROL::CauchyPoint< Real >::cauchypoint_unc(), ROL::GradientStep< 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::CompositeStep< Real >::computeQuasinormalStep(), ROL::ColemanLiModel< Real >::computeReflectiveStep(), ROL::LinMore< Real >::dbreakpt(), ROL::LinMore< Real >::dcauchy(), ROL::LinMore< Real >::dgpstep(), ROL::LinMore< Real >::dprsrch(), ROL::LinMore< Real >::dtrpcg(), ROL::TrustRegionModel< Real >::dualTransform(), ROL::KelleySachsModel< Real >::dualTransform(), ROL::QuadraticPenalty< Real >::getConstraintVec(), ROL::QuadraticPenalty_SimOpt< Real >::getConstraintVec(), ROL::RiskNeutralObjective< Real >::getGradient(), ROL::InteriorPoint::PenalizedObjective< Real >::getObjectiveGradient(), ROL::Objective_FSsolver< Real >::gradient(), ROL::ZOO::Objective_SumOfSquares< Real >::gradient(), ROL::LogBarrierObjective< Real >::gradient(), ROL::LinearObjective< 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::ObjectiveMMA< Real >::gradient(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::RiskNeutralObjective< Real >::gradient(), ROL::ObjectiveFromBoundConstraint< Real >::gradient(), ROL::Fletcher< 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::ZOO::Objective_SumOfSquares< Real >::invHessVec(), ROL::ConicApproximationModel< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), main(), ROL::ConicApproximationModel< Real >::precond(), ROL::Objective< Real >::precond(), ROL::RiskNeutralObjective< Real >::precond(), ROL::StochasticObjective< Real >::precond(), ROL::Reduced_Objective_SimOpt< Real >::precond(), ROL::TrustRegionModel< Real >::primalTransform(), ROL::KelleySachsModel< Real >::primalTransform(), ROL::ColemanLiModel< Real >::primalTransform(), ROL::RandomizeFeasibleVector(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::reg_hessVec(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::LinMore< Real >::run(), BoundConstraint_BurgersControl< Real >::setVectorToLowerBound(), BoundConstraint_BurgersControl< Real >::setVectorToUpperBound(), ROL::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::ZOO::Objective_PoissonInversion< Real >::solve_poisson(), ROL::RangeSpaceOperator< Real >::solveAugmentedSystem(), ROL::NullSpaceOperator< Real >::solveAugmentedSystem(), ROL::ScalarLinearConstraint< Real >::solveAugmentedSystem(), ROL::Fletcher< Real >::solveAugmentedSystem(), ROL::BoundFletcher< Real >::solveAugmentedSystem(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::BatchManager< Real >::sumAll(), ROL::TrustRegion< Real >::update(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::LineSearch< Real >::updateIterate(), ROL::UpperBoundToConstraint< Real >::value(), ROL::LowerBoundToConstraint< Real >::value(), and ROL::BinaryConstraint< Real >::value().

template<class Real>
virtual const Vector& ROL::Vector< Real >::dual ( void  ) const
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.

Returns
A const reference to dual representation.

By default, returns the current object. Please overload if you need a dual representation.


Reimplemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorDual< 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 >, ROL::DualAtomVector< Real >, ROL::ProfiledVector< Ordinal, Real >, ROL::RieszDualVector< Real >, OptStdVector< Real, Element >, ROL::DualProbabilityVector< Real >, ROL::SimulatedVector< Real >, ROL::DualScaledStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::PrimalAtomVector< Real >, 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 226 of file ROL_Vector.hpp.

Referenced by ROL::CompositeStep< Real >::accept(), ROL::NewtonKrylovStep< Real >::PrecondNK::apply(), ROL::ProjectedNewtonKrylovStep< Real >::PrecondPNK::apply(), ROL::Fletcher< Real >::AugSystemPrecond::apply(), ROL::PrimalDualActiveSetStep< Real >::PrecondPD::apply(), ROL::BoundFletcher< Real >::AugSystemPrecond::apply(), ROL::RiskNeutralConstraint< Real >::applyAdjointHessian(), ROL::RiskNeutralConstraint< Real >::applyAdjointJacobian(), ROL::Constraint< Real >::applyAdjointJacobian(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::Constraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::BarzilaiBorwein< Real >::applyB(), ROL::lDFP< Real >::applyB(), ROL::lSR1< Real >::applyB(), ROL::lDFP< Real >::applyB0(), ROL::Secant< Real >::applyB0(), ROL::lSR1< Real >::applyB0(), ROL::lBFGS< Real >::applyH(), ROL::lDFP< Real >::applyH(), ROL::BarzilaiBorwein< Real >::applyH(), ROL::lSR1< Real >::applyH(), ROL::lDFP< Real >::applyH0(), ROL::lSR1< Real >::applyH0(), ROL::Secant< Real >::applyH0(), ROL::ScalarLinearConstraint< Real >::applyJacobian(), ROL::ConstraintFromObjective< Real >::applyJacobian(), ROL::Constraint_State< Real >::applyPreconditioner(), ROL::Constraint< Real >::applyPreconditioner(), ROL::AugmentedLagrangian< Real >::AugmentedLagrangian(), ROL::AugmentedLagrangian_SimOpt< Real >::AugmentedLagrangian_SimOpt(), ROL::BoundFletcher< Real >::BoundFletcher(), ROL::CauchyPoint< Real >::cauchypoint_unc(), ROL::DynamicObjectiveCheck< Real >::check(), ROL::DynamicConstraintCheck< Real >::check(), ROL::Constraint< Real >::checkAdjointConsistencyJacobian(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_1(), ROL::Constraint_SimOpt< Real >::checkAdjointConsistencyJacobian_2(), ROL::Constraint< Real >::checkApplyAdjointJacobian(), 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::TrustRegionStep< Real >::computeCriticalityMeasure(), ROL::computeDenseHessian(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), ROL::RandVarFunctional< Real >::computeGradVec(), ROL::CompositeObjective< Real >::computeHessVec(), ROL::CompositeObjective_SimOpt< Real >::computeHessVec11(), ROL::CompositeObjective_SimOpt< Real >::computeHessVec12(), ROL::CompositeObjective_SimOpt< Real >::computeHessVec21(), ROL::CompositeObjective_SimOpt< Real >::computeHessVec22(), ROL::FletcherStep< Real >::computeProjGradientNorm(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::computeScaledDenseHessian(), ROL::LinMore< Real >::dcauchy(), ROL::LinMore< Real >::dprsrch(), ROL::LinMore< Real >::dtrpcg(), ROL::Fletcher< Real >::Fletcher(), ROL::PH_DeviationObjective< Real >::getGradient(), ROL::PH_ProbObjective< Real >::getGradient(), ROL::PH_bPOEObjective< Real >::getGradient(), ROL::PH_RegretObjective< Real >::getGradient(), ROL::PH_ErrorObjective< Real >::getGradient(), ROL::PH_RiskObjective< Real >::getGradient(), ROL::LineSearchStep< Real >::GradDotStep(), ROL::Objective_FSsolver< Real >::gradient(), ROL::Objective_FSsolver< Real >::hessVec(), ROL::PH_Objective< Real >::hessVec(), ROL::RiskNeutralConstraint< Real >::init(), ROL::CompositeObjective< Real >::initialize(), ROL::RiskNeutralObjective< Real >::initialize(), ROL::CompositeObjective_SimOpt< Real >::initialize(), ROL::TrustRegionModel< 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::ColemanLiModel< Real >::minimize1D(), ROL::NonlinearLeastSquaresObjective< Real >::NonlinearLeastSquaresObjective(), ROL::NonlinearLeastSquaresObjective_Dynamic< Real >::NonlinearLeastSquaresObjective_Dynamic(), ROL::NonlinearLeastSquaresObjective_SimOpt< Real >::NonlinearLeastSquaresObjective_SimOpt(), ROL::InteriorPoint::PenalizedObjective< Real >::PenalizedObjective(), ROL::Objective< Real >::precond(), ROL::RiskNeutralObjective< Real >::precond(), ROL::StochasticObjective< Real >::precond(), ROL::Reduced_Objective_SimOpt< 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::DynamicConstraint< Real >::solve(), ROL::Constraint_SimOpt< Real >::solve(), ROL::ScalarLinearConstraint< Real >::solveAugmentedSystem(), ROL::Constraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::TrustRegion< Real >::update(), ROL::Bundle< Real >::update(), ROL::Objective_FSsolver< Real >::value(), ROL::ScalarLinearConstraint< Real >::value(), ROL::TrustRegionModel< Real >::value(), ROL::KelleySachsModel< Real >::value(), and ROL::ColemanLiModel< Real >::value().

template<class Real>
virtual void ROL::Vector< Real >::applyUnary ( const Elementwise::UnaryFunction< Real > &  f)
inlinevirtual
template<class Real>
virtual void ROL::Vector< Real >::applyBinary ( const Elementwise::BinaryFunction< Real > &  f,
const Vector< Real > &  x 
)
inlinevirtual
template<class Real>
virtual Real ROL::Vector< Real >::reduce ( const Elementwise::ReductionOp< Real > &  r) const
inlinevirtual
template<class Real>
virtual void ROL::Vector< Real >::print ( std::ostream &  outStream) const
inlinevirtual
template<class Real>
virtual void ROL::Vector< Real >::setScalar ( const Real  C)
inlinevirtual

Set \(y \leftarrow C\) where \(C\in\mathbb{R}\).

Parameters
[in]Cis 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::SimulatedVector< Real >, ROL::ProfiledVector< Ordinal, 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 263 of file ROL_Vector.hpp.

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

template<class Real>
virtual void ROL::Vector< Real >::randomize ( const Real  l = 0.0,
const Real  u = 1.0 
)
inlinevirtual

Set vector to be uniform random between [l,u].

Parameters
[in]lis a the lower bound.
[in]uis 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::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 280 of file ROL_Vector.hpp.

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

template<class Real>
virtual std::vector<Real> ROL::Vector< Real >::checkVector ( const Vector< Real > &  x,
const Vector< Real > &  y,
const bool  printToStream = true,
std::ostream &  outStream = std::cout 
) const
inlinevirtual

Verify vector-space methods.

Parameters
[in]xis a vector.
[in]yis 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:

  • Commutativity of addition: \(\mathtt{*this} + x = x + \mathtt{*this}\).
  • Associativity of addition: \(\mathtt{*this} + (x + y) = (\mathtt{*this} + x) + y\).
  • Identity element of addition: \(0 + x = x\).
  • Inverse elements of addition: \(\mathtt{*this} + (- \mathtt{*this}) = 0\).
  • Identity element of scalar multiplication: \( 1 \cdot \mathtt{*this} = \mathtt{*this} \).
  • Consistency of scalar multiplication with field multiplication: \(a (b \cdot \mathtt{*this}) = (a b) \cdot \mathtt{*this}\).
  • Distributivity of scalar multiplication with respect to field addition: \((a+b) \cdot \mathtt{*this} = a \cdot \mathtt{*this} + b \cdot \mathtt{*this}\).
  • Distributivity of scalar multiplication with respect to vector addition: \(a \cdot (\mathtt{*this} + x) = a \cdot \mathtt{*this} + a \cdot x\).
  • Commutativity of dot (inner) product over the field of reals: \((\mathtt{*this}, x) = (x, \mathtt{*this})\).
  • Additivity of dot (inner) product: \((\mathtt{*this}, x+y) = (\mathtt{*this}, x) + (\mathtt{*this}, y)\).
  • Consistency of scalar multiplication and norm: \(\|{\mathtt{*this}} / {\|\mathtt{*this}\|} \| = 1\).
  • Reflexivity: \(\mbox{dual}(\mbox{dual}(\mathtt{*this})) = \mathtt{*this}\) .

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


The documentation for this class was generated from the following file: