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 Teuchos::RCP< 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 Teuchos::RCP< 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 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 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 74 of file ROL_Vector.hpp.
|
inlinevirtual |
Definition at line 77 of file ROL_Vector.hpp.
References ROL::Vector< Real >::clone(), ROL::Vector< Real >::dot(), ROL::Vector< Real >::norm(), ROL::Vector< Real >::plus(), and ROL::Vector< Real >::scale().
|
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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::RiskVector< Real >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::CplxStdVector< Real, complex >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::CArrayVector< Real, Element >, and ROL::Vector_SimOpt< Real >.
Referenced by ROL::CompositeStep< Real >::accept(), ROL::Bundle< Real >::aggregate(), ROL::ProjectedHessian< Real >::apply(), ROL::ProjectedPreconditioner< Real >::apply(), ROL::BoundInequalityConstraint< Real >::applyAdjointJacobian(), ROL::ProjectedHessian< Real >::applyInverse(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian(), ROL::Vector< Real >::axpy(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::CompositeStep< Real >::computeLagrangeMultiplier(), ROL::Constraints< Real >::computeProjectedStep(), ROL::BoundConstraint< Real >::computeProjectedStep(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::Reduced_Objective_SimOpt< Real >::gradient(), ROL::Reduced_ParametrizedObjective_SimOpt< Real >::gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::gradient(), ROL::ObjectiveFromBoundConstraint< Real >::hessVec(), ROL::Reduced_Objective_SimOpt< Real >::hessVec(), ROL::AugmentedLagrangian< Real >::hessVec(), ROL::Reduced_ParametrizedObjective_SimOpt< Real >::hessVec(), ROL::ProjectedObjective< Real >::reducedHessVec(), ROL::ProjectedObjective< Real >::reducedInvHessVec(), ROL::ProjectedObjective< Real >::reducedPrecond(), ROL::GMRES< Real >::run(), ROL::Vector< Real >::set(), ROL::EqualityConstraint< Real >::solveAugmentedSystem(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::AugmentedLagrangianStep< Real >::update(), ROL::InteriorPointStep< Real >::update(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::CompositeStep< Real >::update(), ROL::BundleStep< Real >::update(), ROL::PrimalDualActiveSetStep< Real >::update(), and ROL::Vector< Real >::~Vector().
|
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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::RiskVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::CArrayVector< Real, Element >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, ROL::CplxStdVector< Real, complex >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, and ROL::Vector_SimOpt< Real >.
Referenced by DyadicOperator< Real >::apply(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::UpperBoundInequalityConstraint< Real >::applyAdjointJacobian(), ROL::ScalarLinearEqualityConstraint< Real >::applyAdjointJacobian(), ROL::BarzilaiBorwein< Real >::applyB(), ROL::Secant< Real >::applyB0(), ROL::lDFP< Real >::applyB0(), ROL::BarzilaiBorwein< Real >::applyH(), ROL::lDFP< Real >::applyH0(), ROL::Secant< Real >::applyH0(), ROL::UpperBoundInequalityConstraint< Real >::applyJacobian(), ROL::EqualityConstraint< Real >::applyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_2(), ROL::CauchyPoint< Real >::cauchypoint_M(), ROL::CauchyPoint< Real >::cauchypoint_unc(), ROL::BundleStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::ZOO::Objective_Zakharov< Real >::dirDeriv(), ROL::ZOO::Objective_SumOfSquares< Real >::gradient(), ROL::LogBarrierObjective< Real >::gradient(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::ZOO::Objective_HS24< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::AugmentedLagrangian< 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::ZOO::Objective_SumOfSquares< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), 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::Vector< Real >::zero(), and ROL::Vector< Real >::~Vector().
|
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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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::DualAtomVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::DualProbabilityVector< Real >, OptStdVector< Real, Element >, ROL::RiskVector< Real >, ROL::DualScaledStdVector< Real, Element >, ROL::PrimalAtomVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::PrimalProbabilityVector< Real >, ROL::StdVector< Real >, OptStdVector< Real, Element >, ROL::CplxStdVector< Real, complex >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::CArrayVector< Real, Element >, ROL::Vector_SimOpt< Real >, and ROL::PrimalScaledStdVector< Real, Element >.
Referenced by ROL::CompositeStep< Real >::accept(), DyadicOperator< Real >::apply(), ROL::lBFGS< Real >::applyB(), ROL::lBFGS< Real >::applyH(), ROL::CauchyPoint< Real >::cauchypoint_CGT(), ROL::CauchyPoint< Real >::cauchypoint_M(), ROL::EqualityConstraint< Real >::checkAdjointConsistencyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::checkAdjointConsistencyJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::checkAdjointConsistencyJacobian_2(), ROL::Objective< Real >::checkGradient(), ROL::Objective< Real >::checkHessSym(), ROL::BundleStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::ZOO::Objective_Zakharov< Real >::dirDeriv(), ROL::TrustRegion< Real >::getPredictedReduction(), ROL::Objective< Real >::gradient(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), ROL::DoubleDogLeg< Real >::run(), ROL::EqualityConstraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::LineSearch< Real >::status(), ROL::lSR1< Real >::update(), ROL::Secant< Real >::update(), ROL::TrustRegion< Real >::update(), ROL::ZOO::Objective_SumOfSquares< Real >::value(), ROL::LinearObjective< Real >::value(), ROL::ZOO::Objective_Zakharov< Real >::value(), and ROL::Vector< Real >::~Vector().
|
pure virtual |
Returns \( \| y \| \) where \(y = \mathtt{*this}\).
Implemented in H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::RiskVector< Real >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, OptStdVector< Real, Element >, ROL::CplxStdVector< Real, complex >, OptStdVector< Real, Element >, ROL::SROMVector< Real >, ROL::CArrayVector< Real, Element >, and ROL::Vector_SimOpt< Real >.
Referenced by ROL::CompositeStep< Real >::accept(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::EqualityConstraint< Real >::applyAdjointJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::EqualityConstraint< Real >::applyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_2(), ROL::CauchyPoint< Real >::cauchypoint_CGT(), ROL::CauchyPoint< Real >::cauchypoint_M(), ROL::EqualityConstraint_SimOpt< Real >::checkInverseAdjointJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::checkInverseJacobian_1(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::TrustRegionStep< Real >::computeCriticalityMeasure(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), 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::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::EqualityConstraint_SimOpt< Real >::solve(), EqualityConstraint_BurgersControl< Real >::solve(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::AugmentedLagrangianStep< Real >::update(), ROL::InteriorPointStep< Real >::update(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::PrimalDualActiveSetStep< Real >::update(), and ROL::Vector< Real >::~Vector().
|
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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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::DualAtomVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::DualProbabilityVector< Real >, ROL::RiskVector< Real >, OptStdVector< Real, Element >, ROL::PrimalAtomVector< Real >, ROL::PartitionedVector< Real >, ROL::DualScaledStdVector< Real, Element >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::PrimalProbabilityVector< Real >, OptStdVector< Real, Element >, ROL::CplxStdVector< Real, complex >, OptStdVector< Real, Element >, ROL::CArrayVector< Real, Element >, ROL::SROMVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::PrimalScaledStdVector< Real, Element >.
Referenced by ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::EqualityConstraint< Real >::applyAdjointJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::EqualityConstraint_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::EqualityConstraint< Real >::applyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_2(), ROL::AugmentedLagrangian< Real >::AugmentedLagrangian(), ROL::Vector< Real >::axpy(), ROL::BoundInequalityConstraint< Real >::BoundInequalityConstraint(), ROL::EqualityConstraint< Real >::checkAdjointConsistencyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::checkAdjointConsistencyJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::checkAdjointConsistencyJacobian_2(), ROL::EqualityConstraint< Real >::checkApplyAdjointHessian(), ROL::EqualityConstraint< Real >::checkApplyAdjointJacobian(), ROL::EqualityConstraint< Real >::checkApplyJacobian(), ROL::Objective< Real >::checkGradient(), ROL::Objective< Real >::checkHessSym(), ROL::Objective< Real >::checkHessVec(), ROL::EqualityConstraint_SimOpt< Real >::checkInverseAdjointJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::checkInverseJacobian_1(), ROL::StochasticProblem< Real >::checkObjectiveGradient(), ROL::StochasticProblem< Real >::checkObjectiveHessVec(), ROL::EqualityConstraint_SimOpt< Real >::checkSolve(), ROL::Vector< Real >::checkVector(), ROL::computeDenseHessian(), ROL::computeDotMatrix(), ROL::Constraints< Real >::computeProjectedGradient(), ROL::BoundConstraint< Real >::computeProjectedGradient(), ROL::LogBarrierObjective< Real >::dirDeriv(), ROL::Objective< Real >::dirDeriv(), ROL::RiskNeutralObjective< Real >::getGradient(), ROL::RiskAverseObjective< Real >::getGradient(), ROL::HMCRObjective< Real >::getGradient(), ROL::BPOEObjective< Real >::getGradient(), ROL::TrustRegion< Real >::getPredictedReduction(), ROL::LinearCombinationObjective< Real >::gradient(), Objective_GrossPitaevskii< Real >::gradient(), ROL::Reduced_Objective_SimOpt< Real >::gradient(), ROL::Reduced_ParametrizedObjective_SimOpt< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::LinearCombinationObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::Reduced_Objective_SimOpt< Real >::hessVec(), ROL::Reduced_ParametrizedObjective_SimOpt< 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::IterationScaling< Real >::initialize(), ROL::BackTracking< Real >::initialize(), ROL::CubicInterp< Real >::initialize(), ROL::GoldenSection< Real >::initialize(), ROL::Bisection< Real >::initialize(), ROL::Brents< Real >::initialize(), ROL::DogLeg< Real >::initialize(), ROL::DoubleDogLeg< Real >::initialize(), ROL::PathBasedTargetLevel< Real >::initialize(), ROL::CauchyPoint< Real >::initialize(), ROL::TruncatedCG< Real >::initialize(), ROL::Step< Real >::initialize(), ROL::LineSearch< Real >::initialize(), ROL::Bundle< Real >::initialize(), ROL::InteriorPointStep< Real >::initialize(), ROL::TrustRegion< Real >::initialize(), ROL::BundleStep< Real >::initialize(), ROL::AugmentedLagrangianStep< Real >::initialize(), ROL::MoreauYosidaPenaltyStep< Real >::initialize(), ROL::CompositeStep< Real >::initialize(), ROL::PrimalDualActiveSetStep< Real >::initialize(), ROL::TrustRegionStep< Real >::initialize(), ROL::LineSearchStep< Real >::initialize(), ROL::LowerBoundInequalityConstraint< Real >::LowerBoundInequalityConstraint(), ROL::MoreauYosidaPenalty< Real >::MoreauYosidaPenalty(), ROL::InteriorPoint::PenalizedObjective< Real >::PenalizedObjective(), ROL::InteriorPoint::PrimalDualSymmetrizer< Real >::PrimalDualSymmetrizer(), ROL::Constraints< Real >::pruneInactive(), ROL::BoundConstraint< Real >::pruneInactive(), ROL::BoundConstraint< Real >::pruneLowerInactive(), ROL::BoundConstraint< Real >::pruneUpperInactive(), ROL::ProjectedObjective< Real >::reducedHessVec(), ROL::ProjectedObjective< Real >::reducedInvHessVec(), ROL::ProjectedObjective< Real >::reducedPrecond(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::GMRES< Real >::run(), ROL::Algorithm< Real >::run(), ROL::EqualityConstraint_SimOpt< Real >::solve(), ROL::EqualityConstraint< Real >::solveAugmentedSystem(), ROL::Secant< Real >::test(), ROL::lSR1< Real >::update(), ROL::Secant< Real >::update(), ROL::MeanVariance< Real >::update(), ROL::MeanDeviation< Real >::update(), Objective_PoissonInversion< Real >::update(), ROL::UpperBoundInequalityConstraint< Real >::UpperBoundInequalityConstraint(), ROL::LogBarrierObjective< Real >::value(), Objective_GrossPitaevskii< Real >::value(), and ROL::Vector< Real >::~Vector().
|
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::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::SROMVector< Real >, ROL::StdVector< Real >, ROL::CplxStdVector< Real, complex >, and ROL::Vector_SimOpt< Real >.
Definition at line 143 of file ROL_Vector.hpp.
References ROL::Vector< Real >::clone(), and ROL::Vector< Real >::plus().
Referenced by ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_11(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_12(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_21(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointHessian_22(), ROL::EqualityConstraint< Real >::applyAdjointJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::EqualityConstraint_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::EqualityConstraint< Real >::applyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyJacobian_2(), ROL::CauchyPoint< Real >::cauchypoint_CGT(), ROL::InteriorPointStep< Real >::compute(), ROL::AugmentedLagrangianStep< Real >::compute(), ROL::MoreauYosidaPenaltyStep< Real >::compute(), ROL::TrustRegionStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::Constraints< Real >::computeProjectedStep(), ROL::BoundConstraint< Real >::computeProjectedStep(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::ZOO::Objective_Zakharov< Real >::dirDeriv(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::Objective< Real >::gradient(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::ObjectiveFromBoundConstraint< Real >::gradient(), ROL::MoreauYosidaPenalty< Real >::gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), ROL::LinearCombinationObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::MoreauYosidaPenalty< Real >::hessVec(), ROL::AugmentedLagrangian< 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::ZOO::Objective_Zakharov< Real >::invHessVec(), main(), ROL::Constraints< Real >::pruneInactive(), ROL::BoundConstraint< Real >::pruneInactive(), ROL::BoundConstraint< Real >::pruneLowerInactive(), ROL::BoundConstraint< Real >::pruneUpperInactive(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::ScalarLinearEqualityConstraint< Real >::solveAugmentedSystem(), ROL::TrustRegion< Real >::update(), ROL::AugmentedLagrangianStep< Real >::update(), ROL::LineSearchStep< Real >::update(), ROL::LineSearch< Real >::updateIterate(), ROL::LowerBoundInequalityConstraint< Real >::value(), and ROL::UpperBoundInequalityConstraint< 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::PartitionedVector< Real >.
Definition at line 157 of file ROL_Vector.hpp.
References ROL::Vector< Real >::scale().
Referenced by ROL::Bundle< Real >::aggregate(), NullOperator< Real >::apply(), ROL::LowerBoundInequalityConstraint< Real >::applyAdjointHessian(), ROL::UpperBoundInequalityConstraint< Real >::applyAdjointHessian(), ROL::BoundInequalityConstraint< Real >::applyAdjointHessian(), ROL::ScalarLinearEqualityConstraint< Real >::applyAdjointHessian(), ROL::ZOO::InequalityConstraint_HS24< Real >::applyAdjointHessian(), ROL::ZOO::EqualityConstraint_HS32< Real >::applyAdjointHessian(), EqualityConstraint_BurgersControl< Real >::applyAdjointHessian_11(), EqualityConstraint_BurgersControl< Real >::applyAdjointHessian_12(), EqualityConstraint_BurgersControl< Real >::applyAdjointHessian_21(), EqualityConstraint_BurgersControl< Real >::applyAdjointHessian_22(), ROL::EqualityConstraint< Real >::applyAdjointJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::EqualityConstraint< Real >::applyJacobian(), ROL::InteriorPoint::PrimalDualResidual< Real >::applyJacobian(), ROL::Vector< Real >::checkVector(), ROL::BundleStep< Real >::compute(), ROL::PrimalDualActiveSetStep< Real >::compute(), ROL::MeanVariance< Real >::getHessVec(), ROL::LinearCombinationObjective< Real >::gradient(), ROL::ZOO::Objective_BVP< Real >::gradient(), ROL::ZOO::Objective_HS25< Real >::gradient(), ROL::ZOO::Objective_HS45< Real >::gradient(), ROL::Objective< Real >::gradient(), ROL::MomentObjective< Real >::gradient(), ROL::RiskNeutralObjective< Real >::gradient(), ROL::CDFObjective< Real >::gradient(), ROL::BPOEObjective< Real >::gradient(), ROL::RiskAverseObjective< Real >::gradient(), ROL::HMCRObjective< Real >::gradient(), ROL::ZOO::Objective_PoissonInversion< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), Objective_BurgersControl< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), Objective_BurgersControl< Real >::gradient_2(), ROL::LinearObjective< Real >::hessVec(), ROL::LinearCombinationObjective< Real >::hessVec(), ROL::Objective< Real >::hessVec(), ROL::RiskNeutralObjective< Real >::hessVec(), ROL::MomentObjective< Real >::hessVec(), ROL::RiskAverseObjective< Real >::hessVec(), ROL::CDFObjective< Real >::hessVec(), ROL::BPOEObjective< Real >::hessVec(), ROL::HMCRObjective< Real >::hessVec(), ROL::Objective_SimOpt< Real >::hessVec_11(), Objective_BurgersControl< Real >::hessVec_11(), ROL::Objective_SimOpt< Real >::hessVec_12(), Objective_BurgersControl< Real >::hessVec_12(), ROL::Objective_SimOpt< Real >::hessVec_21(), Objective_BurgersControl< Real >::hessVec_21(), ROL::Objective_SimOpt< Real >::hessVec_22(), Objective_BurgersControl< Real >::hessVec_22(), main(), ROL::RiskMeasure< Real >::reset(), ROL::ConjugateGradients< Real >::run(), ROL::ConjugateResiduals< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::GMRES< Real >::run(), ROL::Vector< Real >::set(), ROL::EqualityConstraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), 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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ConDualStdVector< Real, Element >, ConDualStdVector< Real, Element >, ConStdVector< Real, Element >, ConStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, OptStdVector< Real, Element >, ROL::CplxStdVector< Real, complex >, OptStdVector< Real, Element >, ROL::CArrayVector< Real, Element >, and ROL::Vector_SimOpt< Real >.
Definition at line 172 of file ROL_Vector.hpp.
Referenced by ROL::EqualityConstraint< Real >::applyAdjointJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::EqualityConstraint< Real >::checkApplyAdjointJacobian(), ROL::computeDenseHessian(), ROL::computeDotMatrix(), ROL::Objective< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), 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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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::DualAtomVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::DualProbabilityVector< Real >, ROL::PartitionedVector< Real >, OptStdVector< Real, Element >, ROL::PrimalAtomVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, OptStdVector< Real, Element >, ROL::PrimalProbabilityVector< Real >, OptStdVector< Real, Element >, ROL::CplxStdVector< Real, complex >, ROL::SROMVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::CArrayVector< Real, Element >.
Definition at line 183 of file ROL_Vector.hpp.
Referenced by ROL::EqualityConstraint< Real >::applyAdjointJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::StdVector< Real >::applyBinary(), ROL::StdVector< Real >::axpy(), ROL::EqualityConstraint< Real >::checkApplyAdjointJacobian(), ROL::computeDenseHessian(), ROL::computeDotMatrix(), ROL::StdVector< Real >::dot(), ROL::Objective< Real >::gradient(), ROL::Objective_SimOpt< Real >::gradient_1(), ROL::Objective_SimOpt< Real >::gradient_2(), and ROL::StdVector< Real >::plus().
|
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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, L2VectorPrimal< Real >, ROL::SROMVector< Real >, ROL::PartitionedVector< Real >, ROL::CplxStdVector< Real, complex >, ROL::StdVector< Real, Element >, and ROL::StdVector< Real >.
Definition at line 196 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(), Identity< Real >::apply(), ROL::DiagonalOperator< Real >::apply(), DyadicOperator< Real >::apply(), ROL::LowerBoundInequalityConstraint< Real >::applyAdjointJacobian(), ROL::UpperBoundInequalityConstraint< Real >::applyAdjointJacobian(), ROL::ScalarLinearEqualityConstraint< Real >::applyAdjointJacobian(), ROL::BarzilaiBorwein< Real >::applyB(), ROL::lDFP< Real >::applyB(), ROL::Secant< Real >::applyB0(), ROL::lDFP< Real >::applyB0(), ROL::lSR1< Real >::applyB0(), ROL::lBFGS< Real >::applyH(), ROL::BarzilaiBorwein< Real >::applyH(), ROL::lDFP< Real >::applyH0(), ROL::lSR1< Real >::applyH0(), ROL::Secant< Real >::applyH0(), ROL::DiagonalOperator< Real >::applyInverse(), ROL::LinearOperator< Real >::applyInverse(), TridiagonalToeplitzOperator< Real >::applyInverse(), ROL::UpperBoundInequalityConstraint< Real >::applyJacobian(), ROL::LowerBoundInequalityConstraint< Real >::applyJacobian(), ROL::EqualityConstraint< Real >::applyPreconditioner(), ROL::EqualityConstraint_SimOpt< Real >::applyPreconditioner(), ROL::CauchyPoint< Real >::cauchypoint_CGT(), ROL::CauchyPoint< Real >::cauchypoint_M(), ROL::CauchyPoint< Real >::cauchypoint_unc(), ROL::BundleStep< Real >::compute(), ROL::InteriorPointStep< Real >::compute(), ROL::AugmentedLagrangianStep< Real >::compute(), ROL::MoreauYosidaPenaltyStep< Real >::compute(), ROL::TrustRegionStep< Real >::compute(), ROL::LineSearchStep< Real >::compute(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::ZOO::Objective_Zakharov< Real >::dirDeriv(), ROL::PartitionedVector< Real >::dual(), ROL::AugmentedLagrangian< Real >::getConstraintVec(), ROL::RiskNeutralObjective< Real >::getGradient(), ROL::RiskAverseObjective< Real >::getGradient(), ROL::HMCRObjective< Real >::getGradient(), ROL::BPOEObjective< Real >::getGradient(), ROL::AugmentedLagrangian< Real >::getObjectiveGradient(), ROL::TrustRegion< Real >::getPredictedReduction(), ROL::ZOO::Objective_SumOfSquares< Real >::gradient(), ROL::LogBarrierObjective< Real >::gradient(), ROL::LinearObjective< Real >::gradient(), ROL::ZOO::Objective_Zakharov< Real >::gradient(), ROL::ObjectiveFromBoundConstraint< Real >::gradient(), ROL::RiskNeutralObjective< Real >::gradient(), ROL::AugmentedLagrangian< Real >::gradient(), ROL::MoreauYosidaPenalty< Real >::gradient(), ROL::LogBarrierObjective< Real >::hessVec(), ROL::ObjectiveFromBoundConstraint< Real >::hessVec(), ROL::ZOO::Objective_SumOfSquares< Real >::invHessVec(), ROL::ZOO::Objective_Zakharov< Real >::invHessVec(), main(), ROL::Objective< Real >::precond(), ROL::RiskNeutralObjective< Real >::precond(), ROL::RiskAverseObjective< Real >::precond(), ROL::Reduced_Objective_SimOpt< Real >::precond(), ROL::Reduced_ParametrizedObjective_SimOpt< Real >::precond(), ROL::BPOEObjective< Real >::precond(), ROL::HMCRObjective< Real >::precond(), 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::StdBoundConstraint< Real >::setVectorToLowerBound(), ROL::BoundConstraint< Real >::setVectorToLowerBound(), BoundConstraint_BurgersControl< Real >::setVectorToLowerBound(), L2BoundConstraint< Real >::setVectorToLowerBound(), H1BoundConstraint< Real >::setVectorToLowerBound(), ROL::StdBoundConstraint< Real >::setVectorToUpperBound(), ROL::BoundConstraint< Real >::setVectorToUpperBound(), BoundConstraint_BurgersControl< Real >::setVectorToUpperBound(), L2BoundConstraint< Real >::setVectorToUpperBound(), H1BoundConstraint< Real >::setVectorToUpperBound(), ROL::EqualityConstraint_SimOpt< Real >::solve(), ROL::ZOO::Objective_PoissonInversion< Real >::solve_poisson(), ROL::ScalarLinearEqualityConstraint< Real >::solveAugmentedSystem(), Normalization_Constraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::BatchManager< Real >::sumAll(), ROL::MoreauYosidaPenaltyStep< Real >::update(), ROL::TrustRegionStep< Real >::update(), ROL::LineSearch< Real >::updateIterate(), ROL::LowerBoundInequalityConstraint< Real >::value(), and ROL::UpperBoundInequalityConstraint< 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 >, H1VectorDual< Real >, H1VectorDual< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, H1VectorPrimal< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorDual< Real >, L2VectorPrimal< 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::DualAtomVector< Real >, OptDualStdVector< Real, Element >, OptDualStdVector< Real, Element >, ROL::DualProbabilityVector< Real >, OptStdVector< Real, Element >, ROL::RiskVector< Real >, ROL::PartitionedVector< Real >, ROL::PrimalAtomVector< Real >, OptStdVector< Real, Element >, ROL::DualScaledStdVector< Real, Element >, OptStdVector< Real, Element >, ROL::CplxStdVector< Real, complex >, ROL::PrimalProbabilityVector< Real >, ROL::SROMVector< Real >, ROL::Vector_SimOpt< Real >, and ROL::PrimalScaledStdVector< Real, Element >.
Definition at line 213 of file ROL_Vector.hpp.
Referenced by ROL::CompositeStep< Real >::accept(), ROL::EqualityConstraint< Real >::applyAdjointJacobian(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::applyAdjointJacobian_2(), ROL::BarzilaiBorwein< Real >::applyB(), ROL::lDFP< Real >::applyB(), ROL::lSR1< Real >::applyB(), ROL::Secant< Real >::applyB0(), ROL::lDFP< Real >::applyB0(), ROL::lSR1< Real >::applyB0(), ROL::lDFP< Real >::applyH(), ROL::lBFGS< Real >::applyH(), ROL::BarzilaiBorwein< Real >::applyH(), ROL::lSR1< Real >::applyH(), ROL::lDFP< Real >::applyH0(), ROL::lSR1< Real >::applyH0(), ROL::Secant< Real >::applyH0(), ROL::ScalarLinearEqualityConstraint< Real >::applyJacobian(), ROL::EqualityConstraint< Real >::applyPreconditioner(), ROL::AugmentedLagrangian< Real >::AugmentedLagrangian(), ROL::CauchyPoint< Real >::cauchypoint_CGT(), ROL::CauchyPoint< Real >::cauchypoint_M(), ROL::CauchyPoint< Real >::cauchypoint_unc(), ROL::EqualityConstraint< Real >::checkAdjointConsistencyJacobian(), ROL::EqualityConstraint_SimOpt< Real >::checkAdjointConsistencyJacobian_1(), ROL::EqualityConstraint_SimOpt< Real >::checkAdjointConsistencyJacobian_2(), ROL::EqualityConstraint< Real >::checkApplyAdjointJacobian(), ROL::Objective< Real >::checkGradient(), ROL::Objective< Real >::checkHessVec(), ROL::TrustRegionStep< Real >::computeCriticalityMeasure(), ROL::AugmentedLagrangianStep< Real >::computeGradient(), ROL::CompositeStep< Real >::computeQuasinormalStep(), ROL::HMCRObjective< Real >::initialize(), ROL::BPOEObjective< Real >::initialize(), ROL::MoreauYosidaPenalty< Real >::MoreauYosidaPenalty(), ROL::Objective< Real >::precond(), ROL::RiskNeutralObjective< Real >::precond(), ROL::RiskAverseObjective< Real >::precond(), ROL::Reduced_Objective_SimOpt< Real >::precond(), ROL::Reduced_ParametrizedObjective_SimOpt< Real >::precond(), ROL::BPOEObjective< Real >::precond(), ROL::HMCRObjective< Real >::precond(), ROL::ProjectedObjective< Real >::reducedHessVec(), ROL::ProjectedObjective< Real >::reducedInvHessVec(), ROL::ProjectedObjective< Real >::reducedPrecond(), ROL::DogLeg< Real >::run(), ROL::DoubleDogLeg< Real >::run(), ROL::TruncatedCG< Real >::run(), ROL::Algorithm< Real >::run(), ROL::ScalarLinearEqualityConstraint< Real >::solveAugmentedSystem(), ROL::EqualityConstraint< Real >::solveAugmentedSystem(), ROL::CompositeStep< Real >::solveTangentialSubproblem(), ROL::TrustRegion< Real >::update(), ROL::RiskNeutralObjective< Real >::update(), ROL::Bundle< Real >::update(), and ROL::ScalarLinearEqualityConstraint< Real >::value().
|
inlinevirtual |
Reimplemented in ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, and ROL::SROMVector< Real >.
Definition at line 217 of file ROL_Vector.hpp.
Referenced by ROL::LogBarrierObjective< Real >::gradient(), and ROL::RandomizeVector().
|
inlinevirtual |
Reimplemented in ROL::PartitionedVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, and ROL::SROMVector< Real >.
Definition at line 222 of file ROL_Vector.hpp.
Referenced by ROL::DiagonalOperator< Real >::apply(), ROL::DiagonalOperator< Real >::applyInverse(), ROL::LogBarrierObjective< Real >::hessVec(), ROL::ObjectiveFromBoundConstraint< Real >::hessVec(), ROL::BoundConstraint< Real >::project(), ROL::BoundConstraint< Real >::pruneLowerActive(), and ROL::BoundConstraint< Real >::pruneUpperActive().
|
inlinevirtual |
Reimplemented in ROL::DualAtomVector< Real >, ROL::PartitionedVector< Real >, ROL::DualProbabilityVector< Real >, ROL::StdVector< Real, Element >, ROL::StdVector< Real >, ROL::PrimalAtomVector< Real >, ROL::PrimalProbabilityVector< Real >, and ROL::SROMVector< Real >.
Definition at line 227 of file ROL_Vector.hpp.
|
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 259 of file ROL_Vector.hpp.
References ROL::Vector< Real >::clone(), and ROL::Vector< Real >::zero().
Referenced by main().