132 namespace ConstrainedOptPack {
138 return this->
D_rng().size() + this->
I_rng().size();
143 return this->
I_rng().size();
148 const MatrixOp& D = this->
D();
160 *out <<
"Converted to dense =\n";
162 *out <<
"This is a " << this->
rows() <<
" x " << this->
cols()
163 <<
" general matrix / identity matrix concatenated matrix object ";
164 if( D_rng.lbound() == 1 ) {
166 *out <<
"[ alpha*D; I ]";
168 *out <<
"[ alpha*D'; I ]";
172 *out <<
"[ I; alpha*D ]";
174 *out <<
"[ I; alpha*D' ]";
176 *out <<
" where alpha and D are:";
178 *out <<
"\nalpha = " << this->
alpha();
179 *out <<
"\nD =\n" <<
D();
virtual const MatrixOp & D() const =0
void Vp_StMtV(VectorMutable *vs_lhs, value_type alpha, BLAS_Cpp::Transp trans_rhs1, const Vector &vs_rhs2, value_type beta) const
virtual vec_ptr_t sub_view(const Range1D &rng) const
Create an abstract view of a vector object .
AbstractLinAlgPack::size_type size_type
virtual vec_mut_ptr_t sub_view(const Range1D &rng)
Create a mutable abstract view of a vector object.
void Vp_StMtV(DVectorSlice *vs_lhs, value_type alpha, const MatrixOp &mwo_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2, value_type beta=1.0)
vs_lhs = alpha * op(mwo_rhs1) * vs_rhs2 + beta * vs_lhs.
Abstract interface for immutable, finite dimensional, coordinate vectors {abstract}.
void Vt_S(VectorMutable *v_lhs, const value_type &alpha)
v_lhs *= alpha
RTOp_value_type value_type
void Vp_StV(VectorMutable *v_lhs, const value_type &alpha, const Vector &v_rhs)
v_lhs = alpha * v_rhs + v_lhs
basic_OSTab< CharT, Traits > & incrTab(const int tabs=1)
std::ostream & output(std::ostream &out) const
std::ostream & output(std::ostream &o, const COOMatrix &coom)
Output stream function for COOMatrix.
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
virtual Range1D I_rng() const =0
. One-based subregion index range class.
virtual value_type alpha() const =0
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)
const f_int f_dbl_prec a[]
Base class for all matrices that support basic matrix operations.
SparseVectorSlice< SparseElement< index_type, value_type > > SpVectorSlice
virtual Range1D D_rng() const =0
Transp trans_not(Transp _trans)
Return the opposite of the transpose argument.
AbstractLinAlgPack::value_type value_type
Abstract interface for mutable coordinate vectors {abstract}.
virtual BLAS_Cpp::Transp D_trans() const =0
void Vp_MtV_assert_compatibility(VectorMutable *v_lhs, const MatrixOp &m_rhs1, BLAS_Cpp::Transp trans_rhs1, const Vector &v_rhs2)
v_lhs += op(m_rhs1) * v_rhs2
size_type cols(size_type rows, size_type cols, BLAS_Cpp::Transp _trans)
Return columns of a possible transposed matrix.
RangePack::Range1D Range1D