58 return(assign_scalar_op_);
66 class init_rtop_server_t {
68 init_rtop_server_t() {
80 init_rtop_server_t init_rtop_server;
84 namespace AbstractLinAlgPack {
126 else if( alpha != 1.0 ) {
147 MatrixOp::mat_mut_ptr_t
MatrixOp & operator=(const MatrixOp &mwo_rhs)
int RTOp_TOp_assign_scalar_set_alpha(RTOp_value_type alpha, struct RTOp_RTOp *op)
Adapter subclass that uses a RTOp_RTOp object.
RTOp_index_type index_type
int RTOp_TOp_assign_scalar_construct(RTOp_value_type alpha, struct RTOp_RTOp *op)
int RTOp_TOp_scale_vector_set_alpha(RTOp_value_type alpha, struct RTOp_RTOp *op)
Teuchos::RCP< MultiVectorMutable > multi_vec_mut_ptr_t
RTOp_value_type value_type
virtual multi_vec_mut_ptr_t mv_sub_view(const Range1D &row_rng, const Range1D &col_rng)
Returns a mutable sub-view of the multi vector.
int RTOp_TOp_assign_vectors_construct(struct RTOp_RTOp *op)
virtual multi_vec_mut_ptr_t mv_clone()
Clone the non-const multi-vector object.
virtual size_type cols() const
Return the number of columns in the matrix.
. One-based subregion index range class.
bool Mp_StM(MatrixOp *mwo_lhs, value_type alpha, BLAS_Cpp::Transp trans_rhs) const
virtual vec_mut_ptr_t diag(int k)=0
Get a mutable diagonal vector.
Base class for all matrices that support basic matrix operations.
Interface for a collection of non-mutable vectors (multi-vector, matrix).
virtual vec_mut_ptr_t row(index_type i)=0
Get a mutable row vector.
Interface for a collection of mutable vectors (multi-vector, matrix).
virtual const VectorSpace & space_cols() const =0
Vector space for vectors that are compatible with the columns of the matrix.
void apply_op(EApplyBy apply_by, const RTOpPack::RTOp &primary_op, const size_t num_multi_vecs, const MultiVector *multi_vecs[], const size_t num_targ_multi_vecs, MultiVectorMutable *targ_multi_vecs[], RTOpPack::ReductTarget *reduct_objs[]=NULL, const index_type primary_first_ele=1, const index_type primary_sub_dim=0, const index_type primary_global_offset=0, const index_type secondary_first_ele=1, const index_type secondary_sub_dim=0)
Apply a reduction/transformation operator column by column and return an array of the reduction objec...
virtual multi_vec_mut_ptr_t create_members(size_type num_vecs) const
Create a set of vector members (a MultiVectorMutable) from the vector space.
void Mt_S(value_type alpha)
virtual vec_mut_ptr_t col(index_type j)=0
Get a mutable column vector.
int RTOp_TOp_scale_vector_construct(RTOp_value_type alpha, struct RTOp_RTOp *op)
#define TEUCHOS_TEST_FOR_EXCEPT(throw_exception_test)