ROL
Public Member Functions | Private Types | Private Attributes | List of all members
ROL::StdVector< Real, Element > Class Template Reference

Provides the ROL::Vector interface for scalar values, to be used, for example, with scalar constraints. More...

#include <ROL_StdVector.hpp>

+ Inheritance diagram for ROL::StdVector< Real, Element >:

Public Member Functions

 StdVector (const Ptr< std::vector< Element > > &std_vec)
 
 StdVector (const int dim, const Element val=0.0)
 
 StdVector (std::initializer_list< Element > ilist)
 
Real & operator[] (int i)
 
const Real & operator[] (int i) const
 
void set (const Vector< Real > &x)
 Set \(y \leftarrow x\) where \(y = \mathtt{*this}\).
 
void plus (const Vector< Real > &x)
 Compute \(y \leftarrow y + x\), where \(y = \mathtt{*this}\).
 
void axpy (const Real alpha, const Vector< Real > &x)
 Compute \(y \leftarrow \alpha x + y\) where \(y = \mathtt{*this}\).
 
void scale (const Real alpha)
 Compute \(y \leftarrow \alpha y\) where \(y = \mathtt{*this}\).
 
virtual Real dot (const Vector< Real > &x) const
 Compute \( \langle y,x \rangle \) where \(y = \mathtt{*this}\).
 
Real norm () const
 Returns \( \| y \| \) where \(y = \mathtt{*this}\).
 
virtual Ptr< Vector< Real > > clone () const
 Clone to make a new (uninitialized) vector.
 
Ptr< const std::vector< Element > > getVector () const
 
Ptr< std::vector< Element > > getVector ()
 
Ptr< Vector< Real > > basis (const int i) const
 Return i-th basis vector.
 
int dimension () const
 Return dimension of the vector space.
 
void applyUnary (const Elementwise::UnaryFunction< Real > &f)
 
void applyBinary (const Elementwise::BinaryFunction< Real > &f, const Vector< Real > &x)
 
Real reduce (const Elementwise::ReductionOp< Real > &r) const
 
void setScalar (const Real C)
 Set \(y \leftarrow C\) where \(C\in\mathbb{R}\).
 
void randomize (const Real l=0.0, const Real u=1.0)
 Set vector to be uniform random between [l,u].
 
virtual void print (std::ostream &outStream) const
 
- Public Member Functions inherited from ROL::Vector< Real >
virtual ~Vector ()
 
virtual void plus (const Vector &x)=0
 Compute \(y \leftarrow y + x\), where \(y = \mathtt{*this}\).
 
virtual void scale (const Real alpha)=0
 Compute \(y \leftarrow \alpha y\) where \(y = \mathtt{*this}\).
 
virtual Real dot (const Vector &x) const =0
 Compute \( \langle y,x \rangle \) where \(y = \mathtt{*this}\).
 
virtual Real norm () const =0
 Returns \( \| y \| \) where \(y = \mathtt{*this}\).
 
virtual ROL::Ptr< Vectorclone () const =0
 Clone to make a new (uninitialized) vector.
 
virtual void axpy (const Real alpha, const Vector &x)
 Compute \(y \leftarrow \alpha x + y\) where \(y = \mathtt{*this}\).
 
virtual void zero ()
 Set to zero vector.
 
virtual ROL::Ptr< Vectorbasis (const int i) const
 Return i-th basis vector.
 
virtual int dimension () const
 Return dimension of the vector space.
 
virtual void set (const Vector &x)
 Set \(y \leftarrow x\) where \(y = \mathtt{*this}\).
 
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.
 
virtual Real apply (const Vector< Real > &x) const
 Apply \(\mathtt{*this}\) to a dual vector. This is equivalent to the call \(\mathtt{this->dot(x.dual())}\).
 
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}\).
 
virtual void randomize (const Real l=0.0, const Real u=1.0)
 Set vector to be uniform random between [l,u].
 
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.
 

Private Types

using size_type = typename std::vector< Real >::size_type
 

Private Attributes

Ptr< std::vector< Element > > std_vec_
 

Detailed Description

template<class Real, class Element = Real>
class ROL::StdVector< Real, Element >

Provides the ROL::Vector interface for scalar values, to be used, for example, with scalar constraints.

Provides the std::vector implementation of the ROL::Vector interface.

Definition at line 61 of file ROL_StdVector.hpp.

Member Typedef Documentation

◆ size_type

template<class Real , class Element = Real>
using ROL::StdVector< Real, Element >::size_type = typename std::vector<Real>::size_type
private

Definition at line 63 of file ROL_StdVector.hpp.

Constructor & Destructor Documentation

◆ StdVector() [1/3]

template<class Real , class Element = Real>
ROL::StdVector< Real, Element >::StdVector ( const Ptr< std::vector< Element > > &  std_vec)
inline

Definition at line 67 of file ROL_StdVector.hpp.

◆ StdVector() [2/3]

template<class Real , class Element = Real>
ROL::StdVector< Real, Element >::StdVector ( const int  dim,
const Element  val = 0.0 
)
inline

Definition at line 69 of file ROL_StdVector.hpp.

References dim, and ROL::StdVector< Real, Element >::std_vec_.

◆ StdVector() [3/3]

template<class Real , class Element = Real>
ROL::StdVector< Real, Element >::StdVector ( std::initializer_list< Element >  ilist)
inline

Definition at line 73 of file ROL_StdVector.hpp.

Member Function Documentation

◆ operator[]() [1/2]

template<class Real , class Element = Real>
Real & ROL::StdVector< Real, Element >::operator[] ( int  i)
inline

Definition at line 76 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

◆ operator[]() [2/2]

template<class Real , class Element = Real>
const Real & ROL::StdVector< Real, Element >::operator[] ( int  i) const
inline

Definition at line 77 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

◆ set()

template<class Real , class Element = Real>
void ROL::StdVector< Real, Element >::set ( const Vector< Real > &  x)
inlinevirtual

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

   @param[in]      x     is a vector.

   On return \f$\mathtt{*this} = x\f$.
   Uses #zero and #plus methods for the computation.
   Please overload if a more efficient implementation is needed.

   ---

Reimplemented from ROL::Vector< Real >.

Reimplemented in L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, and H1VectorDual< Real >.

Definition at line 79 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::dimension(), ROL::Vector< Real >::dimension(), ROL::StdVector< Real, Element >::getVector(), and ROL::StdVector< Real, Element >::std_vec_.

Referenced by main(), and testRandomInputs().

◆ plus()

template<class Real , class Element = Real>
void ROL::StdVector< Real, Element >::plus ( const Vector< Real > &  x)
inlinevirtual

◆ axpy()

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

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

   @param[in]      alpha is the scaling of @b x.
   @param[in]      x     is a vector.

   On return \f$\mathtt{*this} = \mathtt{*this} + \alpha x \f$.
   Uses #clone, #set, #scale and #plus for the computation.
   Please overload if a more efficient implementation is needed.

   ---

Reimplemented from ROL::Vector< Real >.

Definition at line 104 of file ROL_StdVector.hpp.

References dim, ROL::StdVector< Real, Element >::dimension(), ROL::Vector< Real >::dimension(), ROL::StdVector< Real, Element >::getVector(), and ROL::StdVector< Real, Element >::std_vec_.

Referenced by main(), ROL::ZOO::Objective_PoissonInversion< Real >::solve_adjoint_sensitivity_equation(), and testRandomInputs().

◆ scale()

template<class Real , class Element = Real>
void ROL::StdVector< Real, Element >::scale ( const Real  alpha)
inlinevirtual

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

   @param[in]      alpha is the scaling of \f$\mathtt{*this}\f$.

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

   ---

Implements ROL::Vector< Real >.

Reimplemented in L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, and H1VectorDual< Real >.

Definition at line 118 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

Referenced by main(), and testRandomInputs().

◆ dot()

template<class Real , class Element = Real>
virtual Real ROL::StdVector< Real, Element >::dot ( const Vector< Real > &  x) const
inlinevirtual

◆ norm()

template<class Real , class Element = Real>
Real ROL::StdVector< Real, Element >::norm ( ) const
inlinevirtual

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

   @return         A nonnegative number equal to the norm of \f$\mathtt{*this}\f$.

   ---

Implements ROL::Vector< Real >.

Reimplemented in L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, and H1VectorDual< Real >.

Definition at line 143 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::dot().

Referenced by main().

◆ clone()

template<class Real , class Element = Real>
virtual Ptr< Vector< Real > > ROL::StdVector< Real, Element >::clone ( ) const
inlinevirtual

◆ getVector() [1/2]

template<class Real , class Element = Real>
Ptr< const std::vector< Element > > ROL::StdVector< Real, Element >::getVector ( ) const
inline

Definition at line 153 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

Referenced by TridiagonalToeplitzOperator< Real >::apply(), ROL::StdConstraint< Real >::applyAdjointHessian(), ROL::StdConstraint< Real >::applyAdjointJacobian(), ROL::StdVector< Real, Element >::applyBinary(), TridiagonalToeplitzOperator< Real >::applyInverse(), ROL::StdConstraint< Real >::applyJacobian(), ROL::StdConstraint< Real >::applyPreconditioner(), ROL::StdVector< Real, Element >::axpy(), ROL::PrimalScaledStdVector< Real, Element >::clone(), ROL::DualScaledStdVector< Real, Element >::clone(), L2VectorPrimal< Real >::clone(), L2VectorDual< Real >::clone(), H1VectorPrimal< Real >::clone(), H1VectorDual< Real >::clone(), ROL::BatchStdVector< Real >::clone(), ROL::ProbabilityVector< Real >::clone(), ROL::PrimalProbabilityVector< Real >::clone(), ROL::DualProbabilityVector< Real >::clone(), ROL::StdObjective< Real >::dirDeriv(), L2VectorPrimal< Real >::dot(), L2VectorDual< Real >::dot(), H1VectorPrimal< Real >::dot(), H1VectorDual< Real >::dot(), ROL::PrimalAtomVector< Real >::dot(), ROL::DualAtomVector< Real >::dot(), ROL::BatchStdVector< Real >::dot(), ROL::PrimalProbabilityVector< Real >::dot(), ROL::DualProbabilityVector< Real >::dot(), ROL::PrimalScaledStdVector< Real, Element >::dot(), ROL::DualScaledStdVector< Real, Element >::dot(), ROL::StdVector< Real, Element >::dot(), ROL::PrimalScaledStdVector< Real, Element >::dual(), ROL::DualScaledStdVector< Real, Element >::dual(), L2VectorPrimal< Real >::dual(), L2VectorDual< Real >::dual(), H1VectorPrimal< Real >::dual(), H1VectorDual< Real >::dual(), ROL::PrimalAtomVector< Real >::dual(), ROL::DualAtomVector< Real >::dual(), ROL::PrimalProbabilityVector< Real >::dual(), ROL::DualProbabilityVector< Real >::dual(), ROL::AtomVector< Real >::getAtom(), ROL::ProbabilityVector< Real >::getNumMyAtoms(), ROL::ProbabilityVector< Real >::getProbability(), ROL::StdObjective< Real >::gradient(), ROL::StdObjective< Real >::hessVec(), ROL::StdObjective< Real >::invHessVec(), ROL::StdVector< Real, Element >::plus(), ROL::StdObjective< Real >::precond(), ROL::BatchStdVector< Real >::reduce(), ROL::StdVector< Real, Element >::set(), ROL::AtomVector< Real >::setAtom(), ROL::ProbabilityVector< Real >::setProbability(), ROL::StdConstraint< Real >::solveAugmentedSystem(), ROL::StdConstraint< Real >::update(), ROL::StdObjective< Real >::update(), ROL::StdObjective< Real >::value(), and ROL::StdConstraint< Real >::value().

◆ getVector() [2/2]

template<class Real , class Element = Real>
Ptr< std::vector< Element > > ROL::StdVector< Real, Element >::getVector ( )
inline

Definition at line 157 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

◆ basis()

template<class Real , class Element = Real>
Ptr< Vector< Real > > ROL::StdVector< Real, Element >::basis ( const int  i) const
inlinevirtual

Return i-th basis vector.

   @param[in] i is the index of the basis function.
   @return A reference-counted pointer to the basis vector with index @b i.

   Overloading the basis is only required if the default gradient implementation
   is used, which computes a finite-difference approximation.

   ---

Reimplemented from ROL::Vector< Real >.

Reimplemented in L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, H1VectorDual< Real >, L2VectorPrimal< Real >, L2VectorDual< Real >, H1VectorPrimal< Real >, and H1VectorDual< Real >.

Definition at line 161 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::clone(), and ROL::StdVector< Real, Element >::dimension().

Referenced by main().

◆ dimension()

template<class Real , class Element = Real>
int ROL::StdVector< Real, Element >::dimension ( void  ) const
inlinevirtual

◆ applyUnary()

template<class Real , class Element = Real>
void ROL::StdVector< Real, Element >::applyUnary ( const Elementwise::UnaryFunction< Real > &  f)
inlinevirtual

Reimplemented from ROL::Vector< Real >.

Definition at line 175 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

Referenced by testRandomInputs().

◆ applyBinary()

template<class Real , class Element = Real>
void ROL::StdVector< Real, Element >::applyBinary ( const Elementwise::BinaryFunction< Real > &  f,
const Vector< Real > &  x 
)
inlinevirtual

◆ reduce()

template<class Real , class Element = Real>
Real ROL::StdVector< Real, Element >::reduce ( const Elementwise::ReductionOp< Real > &  r) const
inlinevirtual

Reimplemented from ROL::Vector< Real >.

Reimplemented in ROL::BatchStdVector< Real >.

Definition at line 198 of file ROL_StdVector.hpp.

References dim, and ROL::StdVector< Real, Element >::std_vec_.

◆ setScalar()

template<class Real , class Element = Real>
void ROL::StdVector< Real, Element >::setScalar ( const Real  C)
inlinevirtual

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

   @param[in]      C     is a scalar.

   On return \f$\mathtt{*this} = C\f$.
   Uses #applyUnary methods for the computation.
   Please overload if a more efficient implementation is needed.

   ---

Reimplemented from ROL::Vector< Real >.

Definition at line 207 of file ROL_StdVector.hpp.

References dim, and ROL::StdVector< Real, Element >::std_vec_.

Referenced by testRandomInputs().

◆ randomize()

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

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

   @param[in]      l     is a the lower bound.
   @param[in]      u     is a the upper bound.

   On return the components of \f$\mathtt{*this}\f$ are uniform
   random numbers on the interval \f$[l,u]\f$.
         The default implementation uses #applyUnary methods for the
         computation. Please overload if a more efficient implementation is
   needed.

   ---

Reimplemented from ROL::Vector< Real >.

Definition at line 212 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

Referenced by main(), and testRandomInputs().

◆ print()

template<class Real , class Element = Real>
virtual void ROL::StdVector< Real, Element >::print ( std::ostream &  outStream) const
inlinevirtual

Reimplemented from ROL::Vector< Real >.

Definition at line 228 of file ROL_StdVector.hpp.

References ROL::StdVector< Real, Element >::std_vec_.

Member Data Documentation

◆ std_vec_

template<class Real , class Element = Real>
Ptr<std::vector<Element> > ROL::StdVector< Real, Element >::std_vec_
private

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