MOOCHO (Single Doxygen Collection)
Version of the Day
|
This template class defines the storage for a concrete matrix class that operations are based on. More...
#include <AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp>
Public Member Functions | |
size_type | rows () const |
size_type | cols () const |
MatrixOp & | operator= (const MatrixOp &m) |
Public Member Functions inherited from AbstractLinAlgPack::MatrixOp | |
virtual void | zero_out () |
M_lhs = 0 : Zero out the matrix. More... | |
virtual void | Mt_S (value_type alpha) |
M_lhs *= alpha : Multiply a matrix by a scalar. More... | |
virtual mat_mut_ptr_t | clone () |
Clone the non-const matrix object (if supported). More... | |
virtual mat_ptr_t | clone () const |
Clone the const matrix object (if supported). More... | |
virtual std::ostream & | output (std::ostream &out) const |
Virtual output function. More... | |
const MatNorm | calc_norm (EMatNormType requested_norm_type=MAT_NORM_1, bool allow_replacement=false) const |
Compute a norm of this matrix. More... | |
virtual mat_ptr_t | sub_view (const Range1D &row_rng, const Range1D &col_rng) const |
Create a transient constant sub-matrix view of this matrix (if supported). More... | |
mat_ptr_t | sub_view (const index_type &rl, const index_type &ru, const index_type &cl, const index_type &cu) const |
Inlined implementation calls this->sub_view(Range1D(rl,ru),Range1D(cl,cu)) . More... | |
virtual mat_ptr_t | perm_view (const Permutation *P_row, const index_type row_part[], int num_row_part, const Permutation *P_col, const index_type col_part[], int num_col_part) const |
Create a permuted view: M_perm = P_row' * M * P_col . More... | |
virtual mat_ptr_t | perm_view_update (const Permutation *P_row, const index_type row_part[], int num_row_part, const Permutation *P_col, const index_type col_part[], int num_col_part, const mat_ptr_t &perm_view) const |
Reinitialize a permuted view: M_perm = P_row' * M * P_col . More... | |
Public Member Functions inherited from AbstractLinAlgPack::MatrixBase | |
virtual | ~MatrixBase () |
Virtual destructor. More... | |
virtual const VectorSpace & | space_cols () const =0 |
Vector space for vectors that are compatible with the columns of the matrix. More... | |
virtual const VectorSpace & | space_rows () const =0 |
Vector space for vectors that are compatible with the rows of the matrix. More... | |
virtual size_type | nz () const |
Return the number of nonzero elements in the matrix. More... | |
Private Attributes | |
M | m_ |
Representation access | |
MatrixWithOpConcreteEncap () | |
The compiler did not generate this default constructor. More... | |
MatrixWithOpConcreteEncap (const M &m) | |
This constructor will have to be overridden. More... | |
M & | m () |
Get the underlying M object. More... | |
const M & | m () const |
This template class defines the storage for a concrete matrix class that operations are based on.
The default copy constructor and assignment operator are allowed.
Definition at line 55 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
|
inline |
The compiler did not generate this default constructor.
Definition at line 64 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
|
inline |
This constructor will have to be overridden.
Definition at line 68 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
|
inline |
Get the underlying M object.
Definition at line 72 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
|
inline |
Definition at line 77 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
|
virtual |
Reimplemented from AbstractLinAlgPack::MatrixBase.
Definition at line 106 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
|
virtual |
Reimplemented from AbstractLinAlgPack::MatrixBase.
Definition at line 111 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
Reimplemented from AbstractLinAlgPack::MatrixOp.
Definition at line 116 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.
|
private |
Definition at line 99 of file AbstractLinAlgPack_MatrixWithOpConcreteEncap.hpp.