ROL
Public Member Functions | Private Attributes | List of all members
ROL::PrimalSimulatedVector< Real > Class Template Reference

#include <ROL_SimulatedVector.hpp>

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

Public Member Functions

 PrimalSimulatedVector (const std::vector< ROL::Ptr< Vector< Real >>> &vecs, const ROL::Ptr< BatchManager< Real >> &bman, const ROL::Ptr< SampleGenerator< Real >> &sampler)
 
Real dot (const Vector< Real > &x) const
 Compute \( \langle y,x \rangle \) where \(y = \mathtt{*this}\). More...
 
ROL::Ptr< Vector< Real > > clone (void) const
 Clone to make a new (uninitialized) vector. More...
 
const Vector< Real > & dual (void) 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...
 
- Public Member Functions inherited from ROL::SimulatedVector< Real >
 SimulatedVector (const std::vector< Vp > &vecs, const VBMp &bman)
 
void set (const V &x)
 Set \(y \leftarrow x\) where \(y = \mathtt{*this}\). More...
 
void plus (const V &x)
 Compute \(y \leftarrow y + x\), where \(y = \mathtt{*this}\). More...
 
void scale (const Real alpha)
 Compute \(y \leftarrow \alpha y\) where \(y = \mathtt{*this}\). More...
 
void axpy (const Real alpha, const V &x)
 Compute \(y \leftarrow \alpha x + y\) where \(y = \mathtt{*this}\). More...
 
Real norm () const
 Returns \( \| y \| \) where \(y = \mathtt{*this}\). More...
 
Vp basis (const int i) const
 Return i-th basis vector. More...
 
int dimension () const
 Return dimension of the vector space. More...
 
void zero ()
 Set to zero vector. More...
 
void applyUnary (const Elementwise::UnaryFunction< Real > &f)
 
void applyBinary (const Elementwise::BinaryFunction< Real > &f, const V &x)
 
Real reduce (const Elementwise::ReductionOp< Real > &r) const
 
void setScalar (const Real C)
 Set \(y \leftarrow C\) where \(C\in\mathbb{R}\). More...
 
void randomize (const Real l=0.0, const Real u=1.0)
 Set vector to be uniform random between [l,u]. More...
 
ROL::Ptr< const Vector< Real > > get (size_type i) const
 
ROL::Ptr< Vector< Real > > get (size_type i)
 
void set (size_type i, const V &x)
 
void zero (size_type i)
 
size_type numVectors () const
 
- Public Member Functions inherited from ROL::Vector< Real >
virtual ~Vector ()
 
virtual void print (std::ostream &outStream) 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...
 

Private Attributes

const std::vector< ROL::Ptr
< Vector< Real > > > 
vecs_
 
const ROL::Ptr< BatchManager
< Real > > 
bman_
 
const ROL::Ptr
< SampleGenerator< Real > > 
sampler_
 
std::vector< ROL::Ptr< Vector
< Real > > > 
dual_vecs_
 
ROL::Ptr< DualSimulatedVector
< Real > > 
dual_pvec_
 
bool isDualInitialized_
 

Additional Inherited Members

- Public Types inherited from ROL::SimulatedVector< Real >
typedef std::vector< PV >
::size_type 
size_type
 

Detailed Description

template<class Real>
class ROL::PrimalSimulatedVector< Real >

Definition at line 62 of file ROL_SimulatedVector.hpp.

Constructor & Destructor Documentation

template<class Real >
ROL::PrimalSimulatedVector< Real >::PrimalSimulatedVector ( const std::vector< ROL::Ptr< Vector< Real >>> &  vecs,
const ROL::Ptr< BatchManager< Real >> &  bman,
const ROL::Ptr< SampleGenerator< Real >> &  sampler 
)
inline

Member Function Documentation

template<class Real >
Real ROL::PrimalSimulatedVector< Real >::dot ( const Vector< Real > &  x) const
inlinevirtual

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\).

Reimplemented from ROL::SimulatedVector< Real >.

Definition at line 321 of file ROL_SimulatedVector.hpp.

References ROL::PrimalSimulatedVector< Real >::bman_, ROL::SimulatedVector< Real >::get(), ROL::SimulatedVector< Real >::numVectors(), ROL::PrimalSimulatedVector< Real >::sampler_, and ROL::PrimalSimulatedVector< Real >::vecs_.

template<class Real >
ROL::Ptr<Vector<Real> > ROL::PrimalSimulatedVector< Real >::clone ( void  ) const
inlinevirtual

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.


Reimplemented from ROL::SimulatedVector< Real >.

Definition at line 345 of file ROL_SimulatedVector.hpp.

References ROL::PrimalSimulatedVector< Real >::bman_, ROL::PrimalSimulatedVector< Real >::sampler_, and ROL::PrimalSimulatedVector< Real >::vecs_.

Referenced by ROL::PrimalSimulatedVector< Real >::PrimalSimulatedVector().

template<class Real >
const Vector<Real>& ROL::PrimalSimulatedVector< 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 from ROL::SimulatedVector< Real >.

Definition at line 353 of file ROL_SimulatedVector.hpp.

References ROL::PrimalSimulatedVector< Real >::bman_, ROL::PrimalSimulatedVector< Real >::dual_pvec_, ROL::PrimalSimulatedVector< Real >::dual_vecs_, ROL::PrimalSimulatedVector< Real >::isDualInitialized_, ROL::PrimalSimulatedVector< Real >::sampler_, and ROL::PrimalSimulatedVector< Real >::vecs_.

Referenced by ROL::PrimalSimulatedVector< Real >::PrimalSimulatedVector().

Member Data Documentation

template<class Real >
const std::vector<ROL::Ptr<Vector<Real> > > ROL::PrimalSimulatedVector< Real >::vecs_
private
template<class Real >
const ROL::Ptr<BatchManager<Real> > ROL::PrimalSimulatedVector< Real >::bman_
private
template<class Real >
const ROL::Ptr<SampleGenerator<Real> > ROL::PrimalSimulatedVector< Real >::sampler_
private
template<class Real >
std::vector<ROL::Ptr<Vector<Real> > > ROL::PrimalSimulatedVector< Real >::dual_vecs_
mutableprivate
template<class Real >
ROL::Ptr<DualSimulatedVector<Real> > ROL::PrimalSimulatedVector< Real >::dual_pvec_
mutableprivate

Definition at line 307 of file ROL_SimulatedVector.hpp.

Referenced by ROL::PrimalSimulatedVector< Real >::dual().

template<class Real >
bool ROL::PrimalSimulatedVector< Real >::isDualInitialized_
mutableprivate

Definition at line 308 of file ROL_SimulatedVector.hpp.

Referenced by ROL::PrimalSimulatedVector< Real >::dual().


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