| 
|   | TOpRandomize (const Scalar &l=-ScalarTraits< Scalar >::one(), const Scalar &u=+ScalarTraits< Scalar >::one()) | 
|   | 
| void  | set_bounds (const Scalar &l, const Scalar &u) | 
|   | 
| void  | set_seed (const unsigned int seed) | 
|   | 
| unsigned int  | get_seed () const  | 
|   | 
| void  | get_reduct_type_num_entries (const Ptr< int > &num_values, const Ptr< int > &num_indexes, const Ptr< int > &num_chars) const  | 
|   | Get the number of entries of each basic data type in the externalized state for a reduction object for this operator.  More...
  | 
|   | 
| Teuchos::RCP< ReductTarget >  | reduct_obj_create () const  | 
|   | Creates a new reduction target object initialized and ready to be used in a reduction.  More...
  | 
|   | 
| void  | reduce_reduct_objs (const ReductTarget &in_reduct_obj, const Ptr< ReductTarget > &inout_reduct_obj) const  | 
|   | Reduce intermediate reduction target objects.  More...
  | 
|   | 
| void  | reduct_obj_reinit (const Ptr< ReductTarget > &reduct_obj) const  | 
|   | Reinitialize an already created reduction object.  More...
  | 
|   | 
| void  | extract_reduct_obj_state (const ReductTarget &reduct_obj, const ArrayView< primitive_value_type > &value_data, const ArrayView< index_type > &index_data, const ArrayView< char_type > &char_data) const  | 
|   | Extract the state of an already created reduction object.  More...
  | 
|   | 
| void  | load_reduct_obj_state (const ArrayView< const primitive_value_type > &value_data, const ArrayView< const index_type > &index_data, const ArrayView< const char_type > &char_data, const Ptr< ReductTarget > &reduct_obj) const  | 
|   | Load the state of an already created reduction object given arrays of primitive objects.  More...
  | 
|   | 
| std::string  | op_name () const  | 
|   | Return the name (as a null-terminated C-style string) of the operator.  More...
  | 
|   | 
| bool  | coord_invariant () const  | 
|   | Returns true if this operator is coordinate invariant.  More...
  | 
|   | 
| Range1D  | range () const  | 
|   | Returns the continuous range of elements that this operator is defined over.  More...
  | 
|   | 
| void  | apply_op (const ArrayView< const ConstSubVectorView< Scalar > > &sub_vecs, const ArrayView< const SubVectorView< Scalar > > &targ_sub_vecs, const Ptr< ReductTarget > &reduct_obj) const  | 
|   | Apply the reduction/transformation operator to a set of sub-vectors.  More...
  | 
|   | 
| DescribableStreamManipulatorState  | describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default) | 
|   | 
| std::ostream &  | operator<< (std::ostream &os, const DescribableStreamManipulatorState &d) | 
|   | 
| virtual std::string  | description () const  | 
|   | 
| virtual void  | describe (FancyOStream &out, const EVerbosityLevel verbLevel=verbLevel_default) const  | 
|   | 
| void  | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const  | 
|   | 
| virtual  | ~Describable () | 
|   | 
|   | LabeledObject () | 
|   | 
| virtual  | ~LabeledObject () | 
|   | 
| virtual void  | setObjectLabel (const std::string &objectLabel) | 
|   | 
| virtual std::string  | getObjectLabel () const  | 
|   | 
 | 
typedef PrimitiveTypeTraits 
< Scalar, Scalar > 
::primitiveType  | primitive_value_type | 
|   | 
| static const EVerbosityLevel  | verbLevel_default | 
|   | 
| virtual void  | get_reduct_type_num_entries_impl (const Ptr< int > &num_values, const Ptr< int > &num_indexes, const Ptr< int > &num_chars) const  | 
|   | 
virtual Teuchos::RCP 
< ReductTarget >  | reduct_obj_create_impl () const  | 
|   | 
| virtual void  | reduce_reduct_objs_impl (const ReductTarget &in_reduct_obj, const Ptr< ReductTarget > &inout_reduct_obj) const  | 
|   | 
| virtual void  | reduct_obj_reinit_impl (const Ptr< ReductTarget > &reduct_obj) const  | 
|   | 
| virtual void  | extract_reduct_obj_state_impl (const ReductTarget &reduct_obj, const ArrayView< primitive_value_type > &value_data, const ArrayView< index_type > &index_data, const ArrayView< char_type > &char_data) const  | 
|   | 
| virtual void  | load_reduct_obj_state_impl (const ArrayView< const primitive_value_type > &value_data, const ArrayView< const index_type > &index_data, const ArrayView< const char_type > &char_data, const Ptr< ReductTarget > &reduct_obj) const  | 
|   | 
| virtual std::string  | op_name_impl () const  | 
|   | 
| virtual bool  | coord_invariant_impl () const  | 
|   | 
| virtual Range1D  | range_impl () const  | 
|   | 
|   | RTOpT (const std::string &op_name_base="") | 
|   | Constructor that creates an operator name appended with the type.  More...
  | 
|   | 
| void  | setOpNameBase (const std::string &op_name_base) | 
|   | Just set the operator name.  More...
  | 
|   | 
template<class Scalar>
class RTOpPack::TOpRandomize< Scalar >
Generate a random vector in the range [l,u]: z0[i] = 0.5*((u-l)*Teuchos::ScalarTraits<Scalar>::random()+(u+l)), i=0...n-1. 
The seed for the random number generator can be set by TOpRandomize<Scalar>::set_seed(s) where s is some unsigned integer. Note that this class generates random numbers based on the initial seed and the global element ID so this should produce the same pseudo-random elements independent of the number of processors being used.
The seed changes every time a new object is created in order to improve the randomness to some degree. 
Definition at line 33 of file RTOpPack_TOpRandomize.hpp.