42 #ifndef ALAP_VECTOR_MUTABLE_HPP
43 #define ALAP_VECTOR_MUTABLE_HPP
45 #include "AbstractLinAlgPack_Vector.hpp"
47 namespace AbstractLinAlgPack {
118 virtual void set_ele( index_type i, value_type val );
168 virtual void axpy( value_type alpha,
const Vector& x );
250 virtual void set_sub_vector(
const RTOpPack::SparseSubVector& sub_vec );
296 ,value_type beta = 1.0
299 y->
Vp_StMtV(alpha,P,P_trans,x,beta);
314 #endif // ALAP_VECTOR_MUTABLE_HPP
virtual vec_mut_ptr_t sub_view(const Range1D &rng)
Create a mutable abstract view of a vector object.
virtual void set_sub_vector(const RTOpPack::SparseSubVector &sub_vec)
Set a specific sub-vector.
virtual void get_sub_vector(const Range1D &rng, RTOpPack::SubVector *sub_vec) const
Get a non-mutable explicit view of a sub-vector.
Abstract interface for immutable, finite dimensional, coordinate vectors {abstract}.
virtual void commit_sub_vector(RTOpPack::MutableSubVector *sub_vec)
Free a mutable explicit view of a sub-vector.
virtual void set_ele(index_type i, value_type val)
Set a specific element of a vector.
Teuchos::RCP< VectorMutable > vec_mut_ptr_t
virtual void zero()
Zeros this vector.
virtual void axpy(value_type alpha, const Vector &x)
Adds a linear combination of another vector to this vector object.
void Vp_StMtV(VectorMutable *v_lhs, value_type alpha, const MatrixOp &M_rhs1, BLAS_Cpp::Transp trans_rhs1, const Vector &v_rhs2, value_type beta=1.0)
v_lhs = alpha * op(M_rhs1) * v_rhs2 + beta * v_lhs (BLAS xGEMV)
virtual void free_sub_vector(RTOpPack::SubVector *sub_vec) const
Free an explicit view of a sub-vector.
virtual VectorMutable & operator=(value_type alpha)
Assign the elements of this vector to a scalar.
virtual void get_sub_vector(const Range1D &rng, RTOpPack::MutableSubVector *sub_vec)
Get a mutable explicit view of a sub-vector.
Abstract interface for mutable coordinate vectors {abstract}.
virtual void Vp_StMtV(value_type alpha, const GenPermMatrixSlice &P, BLAS_Cpp::Transp P_trans, const Vector &x, value_type beta)
Perform a gather or scatter operation with a vector.
Concrete matrix type to represent general permutation (mapping) matrices.