ML
Version of the Day
|
Basic class for distributed double-precision vectors. More...
#include <MLAPI_MultiVector.h>
Public Member Functions | |
bool | IsAlias (const MultiVector &rhs) const |
MultiVector () | |
Default constructor. | |
MultiVector (const Space &VectorSpace, const int NumVectors=1, bool SetToZero=true) | |
Constructor for a given Space. | |
MultiVector (const Space &VectorSpace, double **Values, const int NumVectors=1) | |
Constructor with a given Space, and user-provided array of values. | |
MultiVector (const Space &VectorSpace, Teuchos::RefCountPtr< DoubleVector > RCPValues) | |
Constructor with a given Space, and user-provided RefCountPtr. | |
MultiVector (const Space &VectorSpace, std::vector< Teuchos::RefCountPtr< DoubleVector > > RCPValues) | |
Constructor with a given Space, and user-provided array of values. | |
MultiVector (const MultiVector &rhs) | |
Copy constructor. | |
~MultiVector () | |
Destructor. | |
void | Reshape () |
Resets this object. | |
void | Reshape (const Space &S, const int NumVectors=1, const bool SetToZero=true) |
Sets the space of this vector. | |
void | Append (const int NumVectors=1, const bool SetToZero=true) |
Appends a new vector. | |
void | Append (const MultiVector &rhs) |
Appends a new vector. | |
void | Delete (const int v) |
Deletes the last vector. | |
MultiVector & | operator= (double rhs) |
Sets all elements of this vector to rhs . | |
MultiVector & | operator= (const MultiVector &rhs) |
Copies the rhs into this object. | |
MultiVector & | operator= (const BaseLinearCombination &rhs) |
Sets the elements from the input BaseLinearCombination. | |
bool | operator== (const MultiVector &) const |
MultiVector & | operator= (const std::string &Label) |
Sets the name of this object, does not touch vector elements or space. | |
const double & | operator() (const int i) const |
Returns the value of local element i (const version). | |
double & | operator() (const int i) |
Returns the value of local element i (non-const version). | |
const double & | operator() (const int i, const int v) const |
Returns the value of local element i . | |
double & | operator() (const int i, const int v) |
Returns the value of local element i (non-const version) | |
const Space & | GetVectorSpace () const |
Returns the Space on which this vector is defined. | |
Space & | GetVectorSpace () |
Returns the Space on which this vector is defined (non-const) | |
int | GetNumVectors () const |
Returns the number of vectors. | |
int | GetMyLength () const |
Returns the local length of each vector. | |
int | GetGlobalLength () const |
Returns the global length of each vector. | |
double * | GetValues (const int v) |
Returns a pointer to the double array (non-const version) | |
const double * | GetValues (const int v) const |
Returns a pointer to the double array (const version) | |
Teuchos::RefCountPtr < DoubleVector > & | GetRCPValues (const int v) |
Returns a pointer to the double array (non-const version) | |
const Teuchos::RefCountPtr < DoubleVector > & | GetRCPValues (const int v) const |
Returns a pointer to the double array (const version) | |
void | SetRCPValues (const Teuchos::RefCountPtr< DoubleVector > &RCPValues, const int v) |
Sets the RefCountPtr<Values_> | |
void | Update (const double alpha, int v=-1) |
Sets this(v) = rhs. | |
void | Update (const MultiVector &rhs) |
Sets this = rhs. | |
void | Update (double alpha, const MultiVector &rhs) |
Sets this = alpha * rhs. | |
void | Update (double alpha, const MultiVector &x, double beta, const MultiVector &y) |
Sets this = alpha * x + beta * y. | |
void | Update (double alpha, const MultiVector &rhs, double beta) |
Sets this = alpha * rhs + beta * this. | |
double | DotProduct (const MultiVector &rhs, int v=-1) const |
Computes the dot product between this vector and rhs . | |
double | Norm2 (int v=-1) const |
Computes the 2-norm of this vector. | |
double | NormInf (int v=-1) const |
Computes the infinite norm of this vector. | |
double | NormOne (int v=-1) const |
Computes the one norm of this vector. | |
void | Reciprocal (int v=-1) |
Replaces each element of the vector with its reciprocal. | |
void | Scale (const double Factor, int v=-1) |
Scales each element by the specified factor. | |
void | Random (int v=-1) |
Populates the vector with random elements. | |
void | Sort (int v=-1, const bool IsIncreasing=false) |
Sorts the component of the vector. | |
virtual std::ostream & | Print (std::ostream &os, const bool verbose=true) const |
Prints basic information about this object on std::ostream. | |
Public Member Functions inherited from MLAPI::BaseObject | |
BaseObject () | |
Constructor with empty label. | |
BaseObject (const std::string &Label) | |
Constructor with given Label. | |
virtual | ~BaseObject () |
Destructor. | |
void | SetLabel (const std::string &Label) |
Sets the Label of this object to Label . | |
const std::string & | GetLabel () const |
Returns the Label of this object. | |
Public Member Functions inherited from MLAPI::CompObject | |
CompObject () | |
Constructor, set counter to 0.0. | |
~CompObject () | |
Destructor. | |
double | GetFlops () const |
Returns the internal counter of flops. | |
void | SetFlops (double Flops) const |
Sets internal counter to Flops . | |
void | UpdateFlops (double Flops) const |
Updates internal counter by summing Flops . | |
Public Member Functions inherited from MLAPI::TimeObject | |
TimeObject () | |
Constructor, set counter to 0.0. | |
~TimeObject () | |
Destructor. | |
void | ResetTimer () const |
Resets the internal timer. | |
void | UpdateTime () const |
Updates the internal timer with the time spent since the last call to ResetTimer(). | |
void | UpdateTime (double t) const |
Updates the internal timer with input value t . | |
double | GetTime () const |
Returns the internally stored counter. | |
Friends | |
std::ostream & | operator<< (std::ostream &os, MultiVector const &mv) |
Additional Inherited Members | |
Protected Attributes inherited from MLAPI::TimeObject | |
Epetra_Time | Time_ |
Object used to track time. | |
double | TotalTime_ |
Internal counter. | |
Basic class for distributed double-precision vectors.