Belos Package Browser (Single Doxygen Collection)
Development
|
#include <BelosGmresPolyOp.hpp>
Public Member Functions | |
GmresPolyMv (const Teuchos::RCP< MV > &mv_in) | |
GmresPolyMv (const Teuchos::RCP< const MV > &mv_in) | |
Teuchos::RCP< MV > | getMV () |
Teuchos::RCP< const MV > | getConstMV () const |
GmresPolyMv * | Clone (const int numvecs) const |
Create a new MultiVec with numvecs columns. More... | |
GmresPolyMv * | CloneCopy () const |
Create a new MultiVec and copy contents of *this into it (deep copy). More... | |
GmresPolyMv * | CloneCopy (const std::vector< int > &index) const |
Creates a new Belos::MultiVec and copies the selected contents of *this into the new multivector (deep copy). The copied vectors from *this are indicated by the index.size() indices in index . More... | |
GmresPolyMv * | CloneViewNonConst (const std::vector< int > &index) |
Creates a new Belos::MultiVec that shares the selected contents of *this . The index of the numvecs vectors copied from *this are indicated by the indices given in index . More... | |
const GmresPolyMv * | CloneView (const std::vector< int > &index) const |
Creates a new Belos::MultiVec that shares the selected contents of *this . The index of the numvecs vectors copied from *this are indicated by the indices given in index . More... | |
ptrdiff_t | GetGlobalLength () const |
The number of rows in the multivector. More... | |
int | GetNumberVecs () const |
The number of vectors (i.e., columns) in the multivector. More... | |
void | MvTimesMatAddMv (const ScalarType alpha, const MultiVec< ScalarType > &A, const Teuchos::SerialDenseMatrix< int, ScalarType > &B, const ScalarType beta) |
Update *this with alpha * A * B + beta * (*this ). More... | |
void | MvAddMv (const ScalarType alpha, const MultiVec< ScalarType > &A, const ScalarType beta, const MultiVec< ScalarType > &B) |
Replace *this with alpha * A + beta * B . More... | |
void | MvScale (const ScalarType alpha) |
Scale each element of the vectors in *this with alpha . More... | |
void | MvScale (const std::vector< ScalarType > &alpha) |
Scale each element of the i -th vector in *this with alpha[i] . More... | |
void | MvTransMv (const ScalarType alpha, const MultiVec< ScalarType > &A, Teuchos::SerialDenseMatrix< int, ScalarType > &B) const |
Compute a dense matrix B through the matrix-matrix multiply alpha * A^T * (*this ). More... | |
void | MvDot (const MultiVec< ScalarType > &A, std::vector< ScalarType > &b) const |
Compute the dot product of each column of *this with the corresponding column of A. More... | |
void | MvNorm (std::vector< typename Teuchos::ScalarTraits< ScalarType >::magnitudeType > &normvec, NormType type=TwoNorm) const |
Compute the norm of each vector in *this . More... | |
void | SetBlock (const MultiVec< ScalarType > &A, const std::vector< int > &index) |
Copy the vectors in A to a set of vectors in *this . More... | |
void | MvRandom () |
Fill all the vectors in *this with random numbers. More... | |
void | MvInit (const ScalarType alpha) |
Replace each element of the vectors in *this with alpha . More... | |
void | MvPrint (std::ostream &os) const |
Print *this multivector to the os output stream. More... | |
Public Member Functions inherited from Belos::MultiVec< ScalarType > | |
MultiVec () | |
Default constructor. More... | |
virtual | ~MultiVec () |
Destructor (virtual for memory safety of derived classes). More... | |
Private Types | |
typedef MultiVecTraits < ScalarType, MV > | MVT |
Private Attributes | |
Teuchos::RCP< MV > | mv_ |
Definition at line 97 of file BelosGmresPolyOp.hpp.
|
private |
Definition at line 178 of file BelosGmresPolyOp.hpp.
|
inline |
Definition at line 101 of file BelosGmresPolyOp.hpp.
|
inline |
Definition at line 104 of file BelosGmresPolyOp.hpp.
|
inline |
Definition at line 108 of file BelosGmresPolyOp.hpp.
|
inline |
Definition at line 109 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Create a new MultiVec with numvecs
columns.
Implements Belos::MultiVec< ScalarType >.
Definition at line 111 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Create a new MultiVec and copy contents of *this
into it (deep copy).
Implements Belos::MultiVec< ScalarType >.
Definition at line 116 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Creates a new Belos::MultiVec and copies the selected contents of *this
into the new multivector (deep copy). The copied vectors from *this
are indicated by the index.size()
indices in index
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 121 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Creates a new Belos::MultiVec that shares the selected contents of *this
. The index of the numvecs
vectors copied from *this
are indicated by the indices given in index
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 126 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Creates a new Belos::MultiVec that shares the selected contents of *this
. The index of the numvecs
vectors copied from *this
are indicated by the indices given in index
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 131 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
The number of rows in the multivector.
Implements Belos::MultiVec< ScalarType >.
Definition at line 136 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
The number of vectors (i.e., columns) in the multivector.
Implements Belos::MultiVec< ScalarType >.
Definition at line 137 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Update *this
with alpha
* A
* B
+ beta
* (*this
).
Implements Belos::MultiVec< ScalarType >.
Definition at line 138 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Replace *this
with alpha
* A
+ beta
* B
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 145 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Scale each element of the vectors in *this
with alpha
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 151 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Scale each element of the i
-th vector in *this
with alpha[i]
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 152 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Compute a dense matrix B
through the matrix-matrix multiply alpha
* A^T
* (*this
).
Implements Belos::MultiVec< ScalarType >.
Definition at line 153 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Compute the dot product of each column of *this with the corresponding column of A.
Compute a vector b
whose entries are the individual dot-products. That is, b[i] = A[i]^H * (*this)[i]
where A[i]
is the i-th column of A.
Implements Belos::MultiVec< ScalarType >.
Definition at line 158 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Compute the norm of each vector in *this
.
normvec | [out] On output, normvec[i] holds the norm of the i-th vector of *this . |
type | [in] The type of norm to compute. The 2-norm is the default. |
Implements Belos::MultiVec< ScalarType >.
Definition at line 163 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Copy the vectors in A
to a set of vectors in *this
.
The numvecs
vectors in A
are copied to a subset of vectors in *this
indicated by the indices given in index
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 167 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Fill all the vectors in *this
with random numbers.
Implements Belos::MultiVec< ScalarType >.
Definition at line 172 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Replace each element of the vectors in *this
with alpha
.
Implements Belos::MultiVec< ScalarType >.
Definition at line 173 of file BelosGmresPolyOp.hpp.
|
inlinevirtual |
Print *this
multivector to the os
output stream.
Implements Belos::MultiVec< ScalarType >.
Definition at line 174 of file BelosGmresPolyOp.hpp.
|
private |
Definition at line 180 of file BelosGmresPolyOp.hpp.