42 #ifndef SLAP_MULTI_VECTOR_MUTABLE_COlS_H
43 #define SLAP_MULTI_VECTOR_MUTABLE_COlS_H
52 namespace AbstractLinAlgPack {
153 mat_mut_ptr_t
clone();
155 mat_ptr_t
clone()
const;
189 #ifdef DOXYGEN_COMPILE
196 std::vector< Teuchos::RCP<VectorMutable> > col_vecs_;
203 #endif // SLAP_MULTI_VECTOR_MUTABLE_COlS_H
Abstract interface for immutable, finite dimensional, coordinate vectors {abstract}.
RTOp_index_type index_type
bool syrk(BLAS_Cpp::Transp M_trans, value_type alpha, value_type beta, MatrixSymOp *sym_lhs) const
RTOp_value_type value_type
MatrixOp & operator=(const MatrixOp &mwo_rhs)
const VectorSpace * space_rows
Default subclass for MultiVectorMutable implemented using columns of separate abstract vectors...
Interface adding operations specific for a symmetric matrix {abstract}.
vec_mut_ptr_t diag(int k)
Returns return.get() == NULL
void initialize(const Teuchos::RCP< const VectorSpace > &space_cols, const Teuchos::RCP< const VectorSpace > &space_rows, Teuchos::RCP< VectorMutable > col_vecs[]=NULL)
Initialize given the spaces for the columns and rows and possibly the column vectors.
const VectorSpace & space_cols() const
. One-based subregion index range class.
VectorMutable * column_vectors
RTOp_index_type size_type
Abstract interface for objects that represent a space for mutable coordinate vectors.
MultiVectorMutableCols()
Construct to initialized.
const VectorSpace & space_rows() const
const VectorSpace * space_cols
access_by_t access_by() const
Returns return & COL_ACCESS == true only.
vec_mut_ptr_t col(index_type j)
Base class for all matrices that support basic matrix operations.
multi_vec_mut_ptr_t mv_sub_view(const Range1D &row_rng, const Range1D &col_rng)
void set_uninitialized()
Set uninitalized.
Interface for a collection of mutable vectors (multi-vector, matrix).
Abstract interface for mutable coordinate vectors {abstract}.
vec_mut_ptr_t row(index_type i)
Returns return.get() == NULL
void Vp_StMtV(VectorMutable *v_lhs, value_type alpha, BLAS_Cpp::Transp trans_rhs1, const Vector &v_rhs2, value_type beta) const
void Mt_S(value_type alpha)