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

#include <ROL_SROMGenerator.hpp>

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

Public Member Functions

 SROMGenerator (ROL::ParameterList &parlist, const Ptr< BatchManager< Real >> &bman, const std::vector< Ptr< Distribution< Real >>> &dist, std::ostream &outStream=std::cout)
 
void refine (void)
 
- Public Member Functions inherited from ROL::SampleGenerator< Real >
virtual ~SampleGenerator ()
 
 SampleGenerator (const ROL::Ptr< BatchManager< Real > > &bman)
 
 SampleGenerator (const SampleGenerator< Real > &sampler)
 
virtual void update (const Vector< Real > &x)
 
virtual int start (void)
 
virtual Real computeError (std::vector< Real > &vals)
 
virtual Real computeError (std::vector< ROL::Ptr< Vector< Real > > > &vals, const Vector< Real > &x)
 
virtual void setSamples (bool inConstructor=false)
 
virtual int numMySamples (void) const
 
virtual std::vector< Real > getMyPoint (const int i) const
 
virtual Real getMyWeight (const int i) const
 
int batchID (void) const
 
int numBatches (void) const
 
void sumAll (Real *input, Real *output, int dim) const
 
void sumAll (Vector< Real > &input, Vector< Real > &output) const
 
void broadcast (Real *input, int cnt, int root) const
 
void barrier (void) const
 
const ROL::Ptr< BatchManager
< Real > > 
getBatchManager (void) const
 
void print (const std::string &filename="samples", const int prec=12) const
 

Private Member Functions

void pruneSamples (const ProbabilityVector< Real > &prob, const AtomVector< Real > &atom)
 
void get_scaling_vectors (std::vector< Real > &typw, std::vector< Real > &typx) const
 
void initialize_vectors (Ptr< ProbabilityVector< Real >> &prob, Ptr< ProbabilityVector< Real >> &prob_lo, Ptr< ProbabilityVector< Real >> &prob_hi, Ptr< ProbabilityVector< Real >> &prob_eq, Ptr< AtomVector< Real >> &atom, Ptr< AtomVector< Real >> &atom_lo, Ptr< AtomVector< Real >> &atom_hi, Ptr< AtomVector< Real >> &atom_eq, Ptr< Vector< Real >> &vec, Ptr< Vector< Real >> &vec_lo, Ptr< Vector< Real >> &vec_hi, Ptr< Vector< Real >> &vec_eq, const Ptr< BatchManager< Real >> &bman) const
 
Ptr< Objective< Real > > initialize_objective (const std::vector< Ptr< Distribution< Real >>> &dist, const Ptr< BatchManager< Real >> &bman, const bool optProb, const bool optAtom, ROL::ParameterList &list) const
 
int numGlobalSamples (void) const
 

Private Attributes

ROL::ParameterList parlist_
 
std::vector< Ptr< Distribution
< Real > > > 
dist_
 
const int dimension_
 
int numSamples_
 
int numMySamples_
 
int numNewSamples_
 
bool adaptive_
 
Real ptol_
 
Real atol_
 

Additional Inherited Members

- Protected Member Functions inherited from ROL::SampleGenerator< Real >
void setPoints (std::vector< std::vector< Real > > &p)
 
void setWeights (std::vector< Real > &w)
 

Detailed Description

template<class Real>
class ROL::SROMGenerator< Real >

Definition at line 61 of file ROL_SROMGenerator.hpp.

Constructor & Destructor Documentation

template<class Real >
ROL::SROMGenerator< Real >::SROMGenerator ( ROL::ParameterList &  parlist,
const Ptr< BatchManager< Real >> &  bman,
const std::vector< Ptr< Distribution< Real >>> &  dist,
std::ostream &  outStream = std::cout 
)
inline

Member Function Documentation

template<class Real >
void ROL::SROMGenerator< Real >::pruneSamples ( const ProbabilityVector< Real > &  prob,
const AtomVector< Real > &  atom 
)
inlineprivate
template<class Real >
void ROL::SROMGenerator< Real >::refine ( void  )
inlinevirtual

Reimplemented from ROL::SampleGenerator< Real >.

Definition at line 183 of file ROL_SROMGenerator.hpp.

template<class Real >
void ROL::SROMGenerator< Real >::get_scaling_vectors ( std::vector< Real > &  typw,
std::vector< Real > &  typx 
) const
inlineprivate
template<class Real >
void ROL::SROMGenerator< Real >::initialize_vectors ( Ptr< ProbabilityVector< Real >> &  prob,
Ptr< ProbabilityVector< Real >> &  prob_lo,
Ptr< ProbabilityVector< Real >> &  prob_hi,
Ptr< ProbabilityVector< Real >> &  prob_eq,
Ptr< AtomVector< Real >> &  atom,
Ptr< AtomVector< Real >> &  atom_lo,
Ptr< AtomVector< Real >> &  atom_hi,
Ptr< AtomVector< Real >> &  atom_eq,
Ptr< Vector< Real >> &  vec,
Ptr< Vector< Real >> &  vec_lo,
Ptr< Vector< Real >> &  vec_hi,
Ptr< Vector< Real >> &  vec_eq,
const Ptr< BatchManager< Real >> &  bman 
) const
inlineprivate
template<class Real >
Ptr<Objective<Real> > ROL::SROMGenerator< Real >::initialize_objective ( const std::vector< Ptr< Distribution< Real >>> &  dist,
const Ptr< BatchManager< Real >> &  bman,
const bool  optProb,
const bool  optAtom,
ROL::ParameterList &  list 
) const
inlineprivate

Definition at line 271 of file ROL_SROMGenerator.hpp.

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

template<class Real >
int ROL::SROMGenerator< Real >::numGlobalSamples ( void  ) const
inlineprivatevirtual

Reimplemented from ROL::SampleGenerator< Real >.

Definition at line 295 of file ROL_SROMGenerator.hpp.

References ROL::SROMGenerator< Real >::numSamples_.

Member Data Documentation

template<class Real >
ROL::ParameterList ROL::SROMGenerator< Real >::parlist_
private

Definition at line 64 of file ROL_SROMGenerator.hpp.

template<class Real >
std::vector<Ptr<Distribution<Real> > > ROL::SROMGenerator< Real >::dist_
private
template<class Real >
const int ROL::SROMGenerator< Real >::dimension_
private
template<class Real >
int ROL::SROMGenerator< Real >::numSamples_
private
template<class Real >
int ROL::SROMGenerator< Real >::numMySamples_
private
template<class Real >
int ROL::SROMGenerator< Real >::numNewSamples_
private

Definition at line 71 of file ROL_SROMGenerator.hpp.

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

template<class Real >
bool ROL::SROMGenerator< Real >::adaptive_
private

Definition at line 72 of file ROL_SROMGenerator.hpp.

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

template<class Real >
Real ROL::SROMGenerator< Real >::ptol_
private
template<class Real >
Real ROL::SROMGenerator< Real >::atol_
private

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