#include "dMatrix.h"
Public Types | |
typedef ColumnVector | column_vector_type |
typedef ComplexDiagMatrix | complex_diag_matrix_type |
typedef Complex | complex_elt_type |
typedef ComplexMatrix | complex_matrix_type |
typedef ColumnVector | real_column_vector_type |
typedef DiagMatrix | real_diag_matrix_type |
typedef double | real_elt_type |
typedef Matrix | real_matrix_type |
typedef RowVector | real_row_vector_type |
typedef RowVector | row_vector_type |
typedef void(* | solve_singularity_handler) (double rcon) |
![]() | |
typedef bool(* | compare_fcn_type) (typename ref_param< T >::type, typename ref_param< T >::type) |
typedef ref_param< T >::type | crefT |
typedef T | element_type |
typedef octave_idx_type | size_type |
Used for operator(), and returned by numel() and size() (beware: signed integer) | |
typedef T | value_type |
Public Member Functions | |
Matrix ()=default | |
template<typename U > | |
Matrix (const Array< U > &a) | |
Matrix (const boolMatrix &a) | |
Matrix (const charMatrix &a) | |
Matrix (const ColumnVector &cv) | |
Matrix (const DiagArray2< double > &a) | |
Matrix (const DiagMatrix &a) | |
Matrix (const dim_vector &dv) | |
Matrix (const dim_vector &dv, double val) | |
template<typename U > | |
Matrix (const MArray< U > &a) | |
Matrix (const Matrix &a)=default | |
Matrix (const MDiagArray2< double > &a) | |
Matrix (const PermMatrix &a) | |
Matrix (const RowVector &rv) | |
Matrix (octave_idx_type r, octave_idx_type c) | |
Matrix (octave_idx_type r, octave_idx_type c, double val) | |
~Matrix ()=default | |
Matrix | abs () const |
boolMatrix | all (int dim=-1) const |
boolMatrix | any (int dim=-1) const |
Matrix | append (const ColumnVector &a) const |
Matrix | append (const DiagMatrix &a) const |
Matrix | append (const Matrix &a) const |
Matrix | append (const RowVector &a) const |
ColumnVector | column (octave_idx_type i) const |
RowVector | column_max () const |
RowVector | column_max (Array< octave_idx_type > &index) const |
RowVector | column_min () const |
RowVector | column_min (Array< octave_idx_type > &index) const |
Matrix | cumprod (int dim=-1) const |
Matrix | cumsum (int dim=-1) const |
DET | determinant () const |
DET | determinant (MatrixType &mattype, octave_idx_type &info, double &rcon, bool calc_cond=true) const |
DET | determinant (octave_idx_type &info) const |
DET | determinant (octave_idx_type &info, double &rcon, bool calc_cond=true) const |
Matrix | diag (octave_idx_type k=0) const |
DiagMatrix | diag (octave_idx_type m, octave_idx_type n) const |
Matrix | extract (octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) const |
Matrix | extract_n (octave_idx_type r1, octave_idx_type c1, octave_idx_type nr, octave_idx_type nc) const |
Matrix & | fill (double val) |
Matrix & | fill (double val, octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) |
ComplexMatrix | fourier () const |
ComplexMatrix | fourier2d () const |
Matrix | hermitian () const |
ComplexMatrix | ifourier () const |
ComplexMatrix | ifourier2d () const |
Matrix & | insert (const ColumnVector &a, octave_idx_type r, octave_idx_type c) |
Matrix & | insert (const DiagMatrix &a, octave_idx_type r, octave_idx_type c) |
Matrix & | insert (const Matrix &a, octave_idx_type r, octave_idx_type c) |
Matrix & | insert (const RowVector &a, octave_idx_type r, octave_idx_type c) |
Matrix | inverse () const |
Matrix | inverse (MatrixType &mattype) const |
Matrix | inverse (MatrixType &mattype, octave_idx_type &info) const |
Matrix | inverse (MatrixType &mattype, octave_idx_type &info, double &rcon, bool force=false, bool calc_cond=true) const |
Matrix | inverse (octave_idx_type &info) const |
Matrix | inverse (octave_idx_type &info, double &rcon, bool force=false, bool calc_cond=true) const |
bool | issymmetric () const |
ColumnVector | lssolve (const ColumnVector &b) const |
ColumnVector | lssolve (const ColumnVector &b, octave_idx_type &info) const |
ColumnVector | lssolve (const ColumnVector &b, octave_idx_type &info, octave_idx_type &rank) const |
ColumnVector | lssolve (const ColumnVector &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) const |
ComplexColumnVector | lssolve (const ComplexColumnVector &b) const |
ComplexColumnVector | lssolve (const ComplexColumnVector &b, octave_idx_type &info) const |
ComplexColumnVector | lssolve (const ComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank) const |
ComplexColumnVector | lssolve (const ComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) const |
ComplexMatrix | lssolve (const ComplexMatrix &b) const |
ComplexMatrix | lssolve (const ComplexMatrix &b, octave_idx_type &info) const |
ComplexMatrix | lssolve (const ComplexMatrix &b, octave_idx_type &info, octave_idx_type &rank) const |
ComplexMatrix | lssolve (const ComplexMatrix &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) const |
Matrix | lssolve (const Matrix &b) const |
Matrix | lssolve (const Matrix &b, octave_idx_type &info) const |
Matrix | lssolve (const Matrix &b, octave_idx_type &info, octave_idx_type &rank) const |
Matrix | lssolve (const Matrix &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) const |
bool | operator!= (const Matrix &a) const |
Matrix & | operator+= (const DiagMatrix &a) |
Matrix & | operator-= (const DiagMatrix &a) |
Matrix & | operator= (const Matrix &a)=default |
bool | operator== (const Matrix &a) const |
Matrix | prod (int dim=-1) const |
Matrix | pseudo_inverse (double tol=0.0) const |
double | rcond () const |
double | rcond (MatrixType &mattype) const |
void | resize (octave_idx_type nr, octave_idx_type nc, double rfv=0) |
RowVector | row (octave_idx_type i) const |
ColumnVector | row_max () const |
ColumnVector | row_max (Array< octave_idx_type > &index) const |
ColumnVector | row_min () const |
ColumnVector | row_min (Array< octave_idx_type > &index) const |
ColumnVector | solve (const ColumnVector &b) const |
ColumnVector | solve (const ColumnVector &b, octave_idx_type &info) const |
ColumnVector | solve (const ColumnVector &b, octave_idx_type &info, double &rcon) const |
ColumnVector | solve (const ColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const |
ComplexColumnVector | solve (const ComplexColumnVector &b) const |
ComplexColumnVector | solve (const ComplexColumnVector &b, octave_idx_type &info) const |
ComplexColumnVector | solve (const ComplexColumnVector &b, octave_idx_type &info, double &rcon) const |
ComplexColumnVector | solve (const ComplexColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const |
ComplexMatrix | solve (const ComplexMatrix &b) const |
ComplexMatrix | solve (const ComplexMatrix &b, octave_idx_type &info) const |
ComplexMatrix | solve (const ComplexMatrix &b, octave_idx_type &info, double &rcon) const |
ComplexMatrix | solve (const ComplexMatrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const |
Matrix | solve (const Matrix &b) const |
Matrix | solve (const Matrix &b, octave_idx_type &info) const |
Matrix | solve (const Matrix &b, octave_idx_type &info, double &rcon) const |
Matrix | solve (const Matrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const |
ColumnVector | solve (MatrixType &mattype, const ColumnVector &b) const |
ColumnVector | solve (MatrixType &mattype, const ColumnVector &b, octave_idx_type &info) const |
ColumnVector | solve (MatrixType &mattype, const ColumnVector &b, octave_idx_type &info, double &rcon) const |
ColumnVector | solve (MatrixType &mattype, const ColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const |
ComplexColumnVector | solve (MatrixType &mattype, const ComplexColumnVector &b) const |
ComplexColumnVector | solve (MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info) const |
ComplexColumnVector | solve (MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info, double &rcon) const |
ComplexColumnVector | solve (MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const |
ComplexMatrix | solve (MatrixType &mattype, const ComplexMatrix &b) const |
ComplexMatrix | solve (MatrixType &mattype, const ComplexMatrix &b, octave_idx_type &info) const |
ComplexMatrix | solve (MatrixType &mattype, const ComplexMatrix &b, octave_idx_type &info, double &rcon) const |
ComplexMatrix | solve (MatrixType &mattype, const ComplexMatrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, bool singular_fallback=true, blas_trans_type transt=blas_no_trans) const |
Matrix | solve (MatrixType &mattype, const Matrix &b) const |
Matrix | solve (MatrixType &mattype, const Matrix &b, octave_idx_type &info) const |
Matrix | solve (MatrixType &mattype, const Matrix &b, octave_idx_type &info, double &rcon) const |
Matrix | solve (MatrixType &mattype, const Matrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, bool singular_fallback=true, blas_trans_type transt=blas_no_trans) const |
Matrix | stack (const ColumnVector &a) const |
Matrix | stack (const DiagMatrix &a) const |
Matrix | stack (const Matrix &a) const |
Matrix | stack (const RowVector &a) const |
Matrix | sum (int dim=-1) const |
Matrix | sumsq (int dim=-1) const |
Matrix | transpose () const |
![]() | |
NDArray () | |
NDArray (const Array< octave_idx_type > &a, bool zero_based=false, bool negative_to_nan=false) | |
template<typename U > | |
NDArray (const Array< U > &a) | |
NDArray (const charNDArray &) | |
NDArray (const dim_vector &dv) | |
NDArray (const dim_vector &dv, double val) | |
template<typename U > | |
NDArray (const intNDArray< U > &a) | |
template<typename U > | |
NDArray (const MArray< U > &a) | |
NDArray (const NDArray &a) | |
~NDArray ()=default | |
NDArray | abs () const |
boolNDArray | all (int dim=-1) const |
bool | all_elements_are_int_or_inf_or_nan () const |
bool | all_elements_are_zero () const |
bool | all_integers () const |
bool | all_integers (double &max_val, double &min_val) const |
boolNDArray | any (int dim=-1) const |
bool | any_element_is_inf_or_nan () const |
bool | any_element_is_nan () const |
bool | any_element_is_negative (bool=false) const |
bool | any_element_is_positive (bool=false) const |
bool | any_element_not_one_or_zero () const |
NDArray & | changesign () |
charNDArray | concat (const charNDArray &rb, const Array< octave_idx_type > &ra_idx) |
ComplexNDArray | concat (const ComplexNDArray &rb, const Array< octave_idx_type > &ra_idx) |
NDArray | concat (const NDArray &rb, const Array< octave_idx_type > &ra_idx) |
NDArray | cummax (Array< octave_idx_type > &index, int dim=-1) const |
NDArray | cummax (int dim=-1) const |
NDArray | cummin (Array< octave_idx_type > &index, int dim=-1) const |
NDArray | cummin (int dim=-1) const |
NDArray | cumprod (int dim=-1) const |
NDArray | cumsum (int dim=-1) const |
NDArray | diag (octave_idx_type k=0) const |
NDArray | diag (octave_idx_type m, octave_idx_type n) const |
NDArray | diff (octave_idx_type order=1, int dim=-1) const |
ComplexNDArray | fourier (int dim=1) const |
ComplexNDArray | fourier2d () const |
ComplexNDArray | fourierNd () const |
ComplexNDArray | ifourier (int dim=1) const |
ComplexNDArray | ifourier2d () const |
ComplexNDArray | ifourierNd () const |
NDArray & | insert (const NDArray &a, const Array< octave_idx_type > &ra_idx) |
NDArray & | insert (const NDArray &a, octave_idx_type r, octave_idx_type c) |
boolNDArray | isfinite () const |
boolNDArray | isinf () const |
boolNDArray | isnan () const |
NDArray | max (Array< octave_idx_type > &index, int dim=-1) const |
NDArray | max (int dim=-1) const |
NDArray | min (Array< octave_idx_type > &index, int dim=-1) const |
NDArray | min (int dim=-1) const |
boolNDArray | operator! () const |
NDArray & | operator= (const NDArray &a) |
NDArray | prod (int dim=-1) const |
NDArray | squeeze () const |
NDArray | sum (int dim=-1) const |
NDArray | sumsq (int dim=-1) const |
bool | too_large_for_float () const |
NDArray | xsum (int dim=-1) const |
![]() | |
MArray () | |
MArray (const Array< U > &a) | |
MArray (const dim_vector &dv) | |
MArray (const dim_vector &dv, const double &val) | |
MArray (const MArray< double > &a) | |
~MArray ()=default | |
void | changesign () |
MArray< double > | hermitian (double(*fcn)(const double &)=nullptr) const |
void | idx_add (const octave::idx_vector &idx, const MArray< double > &vals) |
void | idx_add (const octave::idx_vector &idx, double val) |
Performs indexed accumulative addition. | |
void | idx_add_nd (const octave::idx_vector &idx, const MArray< double > &vals, int dim=-1) |
void | idx_max (const octave::idx_vector &idx, const MArray< double > &vals) |
void | idx_min (const octave::idx_vector &idx, const MArray< double > &vals) |
MArray< double > | ipermute (const Array< octave_idx_type > &vec) const |
MArray< double > & | operator= (const MArray< double > &a) |
MArray< double > | permute (const Array< octave_idx_type > &vec, bool inv=false) const |
MArray< double > | reshape (const dim_vector &new_dims) const |
MArray | squeeze () const |
MArray< double > | transpose () const |
![]() | |
Array () | |
Empty ctor (0 by 0). | |
Array (Array< T, Alloc > &&a) | |
Array (const Array< T, Alloc > &a) | |
No type conversion case. | |
Array (const Array< T, Alloc > &a, const dim_vector &dv) | |
Reshape constructor. | |
template<typename U , typename A = Alloc> | |
Array (const Array< U, A > &a) | |
Type conversion case. | |
template<template< typename... > class Container> | |
Array (const Container< T > &a, const dim_vector &dv) | |
Constructor from standard library sequence containers. | |
Array (const dim_vector &dv) | |
nD uninitialized ctor. | |
Array (const dim_vector &dv, const T &val) | |
nD initialized ctor. | |
Array (T *ptr, const dim_vector &dv, const Alloc &xallocator=Alloc()) | |
virtual | ~Array () |
Array< T, Alloc > | as_column () const |
Return the array as a column vector. | |
Array< T, Alloc > | as_matrix () const |
Return the array as a matrix. | |
Array< T, Alloc > | as_row () const |
Return the array as a row vector. | |
void | clear () |
void | clear (const dim_vector &dv) |
void | clear (octave_idx_type r, octave_idx_type c) |
void | fill (const T &val) |
Array< octave_idx_type > | find (octave_idx_type, bool) const |
Array< octave_idx_type > | find (octave_idx_type, bool) const |
sortmode | is_sorted_rows (sortmode) const |
sortmode | is_sorted_rows (sortmode) const |
sortmode | issorted (sortmode) const |
sortmode | issorted (sortmode) const |
Array< octave_idx_type > | lookup (const Array< octave::cdef_object > &, sortmode) const |
Array< octave_idx_type > | lookup (const Array< octave::idx_vector > &, sortmode) const |
octave_idx_type | lookup (octave::cdef_object const &, sortmode) const |
octave_idx_type | lookup (octave::idx_vector const &, sortmode) const |
void | make_unique () |
octave_idx_type | nnz () const |
octave_idx_type | nnz () const |
Array< octave::cdef_object > | nth_element (const octave::idx_vector &, int) const |
Array< octave::idx_vector > | nth_element (const octave::idx_vector &, int) const |
octave_idx_type | numel () const |
Number of elements in the array. | |
Array< T, Alloc > & | operator= (Array< T, Alloc > &&a) |
Array< T, Alloc > & | operator= (const Array< T, Alloc > &a) |
Array< octave::cdef_object > | sort (Array< octave_idx_type > &sidx, int, sortmode) const |
Array< octave::idx_vector > | sort (Array< octave_idx_type > &sidx, int, sortmode) const |
Array< octave::cdef_object > | sort (int, sortmode) const |
Array< octave::idx_vector > | sort (int, sortmode) const |
Array< octave_idx_type > | sort_rows_idx (sortmode) const |
Array< octave_idx_type > | sort_rows_idx (sortmode) const |
octave_idx_type | dim1 () const |
octave_idx_type | rows () const |
octave_idx_type | dim2 () const |
octave_idx_type | cols () const |
octave_idx_type | columns () const |
octave_idx_type | dim3 () const |
Size of the specified dimension. | |
octave_idx_type | pages () const |
Size of the specified dimension. | |
size_type | size (const size_type d) const |
Size of the specified dimension. | |
std::size_t | byte_size () const |
Size of the specified dimension. | |
const dim_vector & | dims () const |
Return a const-reference so that dims ()(i) works efficiently. | |
Array< T, Alloc > | squeeze () const |
Chop off leading singleton dimensions. | |
octave_idx_type | compute_index (octave_idx_type i, octave_idx_type j) const |
Size of the specified dimension. | |
octave_idx_type | compute_index (octave_idx_type i, octave_idx_type j, octave_idx_type k) const |
Size of the specified dimension. | |
octave_idx_type | compute_index (const Array< octave_idx_type > &ra_idx) const |
Size of the specified dimension. | |
octave_idx_type | compute_index_unchecked (const Array< octave_idx_type > &ra_idx) const |
Size of the specified dimension. | |
T & | xelem (octave_idx_type n) |
Size of the specified dimension. | |
crefT | xelem (octave_idx_type n) const |
Size of the specified dimension. | |
T & | xelem (octave_idx_type i, octave_idx_type j) |
Size of the specified dimension. | |
crefT | xelem (octave_idx_type i, octave_idx_type j) const |
Size of the specified dimension. | |
T & | xelem (octave_idx_type i, octave_idx_type j, octave_idx_type k) |
Size of the specified dimension. | |
crefT | xelem (octave_idx_type i, octave_idx_type j, octave_idx_type k) const |
Size of the specified dimension. | |
T & | xelem (const Array< octave_idx_type > &ra_idx) |
Size of the specified dimension. | |
crefT | xelem (const Array< octave_idx_type > &ra_idx) const |
Size of the specified dimension. | |
T & | checkelem (octave_idx_type n) |
Size of the specified dimension. | |
T & | checkelem (octave_idx_type i, octave_idx_type j) |
Size of the specified dimension. | |
T & | checkelem (octave_idx_type i, octave_idx_type j, octave_idx_type k) |
Size of the specified dimension. | |
T & | checkelem (const Array< octave_idx_type > &ra_idx) |
Size of the specified dimension. | |
T & | elem (octave_idx_type n) |
Size of the specified dimension. | |
T & | elem (octave_idx_type i, octave_idx_type j) |
Size of the specified dimension. | |
T & | elem (octave_idx_type i, octave_idx_type j, octave_idx_type k) |
Size of the specified dimension. | |
T & | elem (const Array< octave_idx_type > &ra_idx) |
Size of the specified dimension. | |
T & | operator() (octave_idx_type n) |
Size of the specified dimension. | |
T & | operator() (octave_idx_type i, octave_idx_type j) |
Size of the specified dimension. | |
T & | operator() (octave_idx_type i, octave_idx_type j, octave_idx_type k) |
Size of the specified dimension. | |
T & | operator() (const Array< octave_idx_type > &ra_idx) |
Size of the specified dimension. | |
crefT | checkelem (octave_idx_type n) const |
Size of the specified dimension. | |
crefT | checkelem (octave_idx_type i, octave_idx_type j) const |
Size of the specified dimension. | |
crefT | checkelem (octave_idx_type i, octave_idx_type j, octave_idx_type k) const |
Size of the specified dimension. | |
crefT | checkelem (const Array< octave_idx_type > &ra_idx) const |
Size of the specified dimension. | |
crefT | elem (octave_idx_type n) const |
Size of the specified dimension. | |
crefT | elem (octave_idx_type i, octave_idx_type j) const |
Size of the specified dimension. | |
crefT | elem (octave_idx_type i, octave_idx_type j, octave_idx_type k) const |
Size of the specified dimension. | |
crefT | elem (const Array< octave_idx_type > &ra_idx) const |
Size of the specified dimension. | |
crefT | operator() (octave_idx_type n) const |
Size of the specified dimension. | |
crefT | operator() (octave_idx_type i, octave_idx_type j) const |
Size of the specified dimension. | |
crefT | operator() (octave_idx_type i, octave_idx_type j, octave_idx_type k) const |
Size of the specified dimension. | |
crefT | operator() (const Array< octave_idx_type > &ra_idx) const |
Size of the specified dimension. | |
Array< T, Alloc > | column (octave_idx_type k) const |
Extract column: A(:,k+1). | |
Array< T, Alloc > | page (octave_idx_type k) const |
Extract page: A(:,:,k+1). | |
Array< T, Alloc > | linear_slice (octave_idx_type lo, octave_idx_type up) const |
Extract a slice from this array as a column vector: A(:)(lo+1:up). | |
Array< T, Alloc > | reshape (octave_idx_type nr, octave_idx_type nc) const |
Size of the specified dimension. | |
Array< T, Alloc > | reshape (const dim_vector &new_dims) const |
Size of the specified dimension. | |
Array< T, Alloc > | permute (const Array< octave_idx_type > &vec, bool inv=false) const |
Size of the specified dimension. | |
Array< T, Alloc > | ipermute (const Array< octave_idx_type > &vec) const |
Size of the specified dimension. | |
bool | issquare () const |
Size of the specified dimension. | |
bool | isempty () const |
Size of the specified dimension. | |
bool | isvector () const |
Size of the specified dimension. | |
bool | is_nd_vector () const |
Size of the specified dimension. | |
Array< T, Alloc > | transpose () const |
Size of the specified dimension. | |
Array< T, Alloc > | hermitian (T(*fcn)(const T &)=nullptr) const |
Size of the specified dimension. | |
const T * | data () const |
Size of the specified dimension. | |
T * | rwdata () |
Size of the specified dimension. | |
T * | fortran_vec () |
Size of the specified dimension. | |
bool | is_shared () const |
Size of the specified dimension. | |
int | ndims () const |
Size of the specified dimension. | |
Array< T, Alloc > | index (const octave::idx_vector &i) const |
Indexing without resizing. | |
Array< T, Alloc > | index (const octave::idx_vector &i, const octave::idx_vector &j) const |
Size of the specified dimension. | |
Array< T, Alloc > | index (const Array< octave::idx_vector > &ia) const |
Size of the specified dimension. | |
virtual T | resize_fill_value () const |
Size of the specified dimension. | |
void | resize2 (octave_idx_type nr, octave_idx_type nc, const T &rfv) |
Resizing (with fill). | |
void | resize2 (octave_idx_type nr, octave_idx_type nc) |
Size of the specified dimension. | |
void | resize1 (octave_idx_type n, const T &rfv) |
Size of the specified dimension. | |
void | resize1 (octave_idx_type n) |
Size of the specified dimension. | |
void | resize (const dim_vector &dv, const T &rfv) |
Size of the specified dimension. | |
void | resize (const dim_vector &dv) |
Size of the specified dimension. | |
Array< T, Alloc > | index (const octave::idx_vector &i, bool resize_ok, const T &rfv) const |
Indexing with possible resizing and fill. | |
Array< T, Alloc > | index (const octave::idx_vector &i, bool resize_ok) const |
Size of the specified dimension. | |
Array< T, Alloc > | index (const octave::idx_vector &i, const octave::idx_vector &j, bool resize_ok, const T &rfv) const |
Size of the specified dimension. | |
Array< T, Alloc > | index (const octave::idx_vector &i, const octave::idx_vector &j, bool resize_ok) const |
Size of the specified dimension. | |
Array< T, Alloc > | index (const Array< octave::idx_vector > &ia, bool resize_ok, const T &rfv) const |
Size of the specified dimension. | |
Array< T, Alloc > | index (const Array< octave::idx_vector > &ia, bool resize_ok) const |
Size of the specified dimension. | |
void | assign (const octave::idx_vector &i, const Array< T, Alloc > &rhs, const T &rfv) |
Indexed assignment (always with resize & fill). | |
void | assign (const octave::idx_vector &i, const Array< T, Alloc > &rhs) |
Size of the specified dimension. | |
void | assign (const octave::idx_vector &i, const octave::idx_vector &j, const Array< T, Alloc > &rhs, const T &rfv) |
Size of the specified dimension. | |
void | assign (const octave::idx_vector &i, const octave::idx_vector &j, const Array< T, Alloc > &rhs) |
Size of the specified dimension. | |
void | assign (const Array< octave::idx_vector > &ia, const Array< T, Alloc > &rhs, const T &rfv) |
Size of the specified dimension. | |
void | assign (const Array< octave::idx_vector > &ia, const Array< T, Alloc > &rhs) |
Size of the specified dimension. | |
void | delete_elements (const octave::idx_vector &i) |
Deleting elements. | |
void | delete_elements (int dim, const octave::idx_vector &i) |
A(:,...,I,...,:) = [] (>= 2 subscripts, one of them is non-colon) | |
void | delete_elements (const Array< octave::idx_vector > &ia) |
Dispatcher to the above two. | |
Array< T, Alloc > & | insert (const Array< T, Alloc > &a, const Array< octave_idx_type > &idx) |
Insert an array into another at a specified position. | |
Array< T, Alloc > & | insert (const Array< T, Alloc > &a, octave_idx_type r, octave_idx_type c) |
This is just a special case for idx = [r c 0 ...]. | |
void | maybe_economize () |
Size of the specified dimension. | |
void | print_info (std::ostream &os, const std::string &prefix) const |
Size of the specified dimension. | |
Array< T, Alloc > | sort (int dim=0, sortmode mode=ASCENDING) const |
Size of the specified dimension. | |
Array< T, Alloc > | sort (Array< octave_idx_type > &sidx, int dim=0, sortmode mode=ASCENDING) const |
Size of the specified dimension. | |
sortmode | issorted (sortmode mode=UNSORTED) const |
Ordering is auto-detected or can be specified. | |
Array< octave_idx_type > | sort_rows_idx (sortmode mode=ASCENDING) const |
Sort by rows returns only indices. | |
sortmode | is_sorted_rows (sortmode mode=UNSORTED) const |
Ordering is auto-detected or can be specified. | |
octave_idx_type | lookup (const T &value, sortmode mode=UNSORTED) const |
Do a binary lookup in a sorted array. | |
Array< octave_idx_type > | lookup (const Array< T, Alloc > &values, sortmode mode=UNSORTED) const |
Ditto, but for an array of values, specializing on the case when values are sorted. | |
octave_idx_type | nnz () const |
Count nonzero elements. | |
Array< octave_idx_type > | find (octave_idx_type n=-1, bool backward=false) const |
Find indices of (at most n) nonzero elements. | |
Array< T, Alloc > | nth_element (const octave::idx_vector &n, int dim=0) const |
Returns the n-th element in increasing order, using the same ordering as used for sort. | |
Array< T, Alloc > | diag (octave_idx_type k=0) const |
Get the kth super or subdiagonal. | |
Array< T, Alloc > | diag (octave_idx_type m, octave_idx_type n) const |
Size of the specified dimension. | |
template<typename U , typename F , typename A = std::allocator<U>> | |
Array< U, A > | map (F fcn) const |
Apply function fcn to each element of the Array<T, Alloc>. | |
template<typename U , typename A = std::allocator<U>> | |
Array< U, A > | map (U(&fcn)(T)) const |
Overloads for function references. | |
template<typename U , typename A = std::allocator<U>> | |
Array< U, A > | map (U(&fcn)(const T &)) const |
Size of the specified dimension. | |
template<typename F , bool zero> | |
bool | test (F fcn) const |
Generic any/all test functionality with arbitrary predicate. | |
template<typename F > | |
bool | test_any (F fcn) const |
Simpler calls. | |
template<typename F > | |
bool | test_all (F fcn) const |
Size of the specified dimension. | |
bool | test_any (bool(&fcn)(T)) const |
Overloads for function references. | |
bool | test_any (bool(&fcn)(const T &)) const |
Size of the specified dimension. | |
bool | test_all (bool(&fcn)(T)) const |
Size of the specified dimension. | |
bool | test_all (bool(&fcn)(const T &)) const |
Size of the specified dimension. | |
bool | optimize_dimensions (const dim_vector &dv) |
Returns true if this->dims () == dv, and if so, replaces this->m_dimensions by a shallow copy of dv. | |
Friends | |
class | ComplexMatrix |
Matrix | imag (const ComplexMatrix &a) |
std::ostream & | operator<< (std::ostream &os, const Matrix &a) |
std::istream & | operator>> (std::istream &is, Matrix &a) |
Matrix | real (const ComplexMatrix &a) |
Additional Inherited Members | |
![]() | |
static octave_idx_type | compute_index (Array< octave_idx_type > &ra_idx, const dim_vector &dimensions) |
static void | increment_index (Array< octave_idx_type > &ra_idx, const dim_vector &dimensions, int start_dimension=0) |
![]() | |
static Array< T, Alloc > | cat (int dim, octave_idx_type n, const Array< T, Alloc > *array_list) |
Concatenation along a specified (0-based) dimension, equivalent to cat(). | |
![]() | |
Array (const Array< T, Alloc > &a, const dim_vector &dv, octave_idx_type l, octave_idx_type u) | |
slice constructor | |
![]() | |
dim_vector | m_dimensions |
Array< T, Alloc >::ArrayRep * | m_rep |
T * | m_slice_data |
octave_idx_type | m_slice_len |
typedef Complex Matrix::complex_elt_type |
typedef double Matrix::real_elt_type |
typedef Matrix Matrix::real_matrix_type |
typedef RowVector Matrix::row_vector_type |
typedef void(* Matrix::solve_singularity_handler) (double rcon) |
|
default |
Referenced by inverse(), lssolve(), and pseudo_inverse().
|
default |
|
default |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
|
explicit |
Definition at line 69 of file dMatrix.cc.
|
explicit |
Definition at line 73 of file dMatrix.cc.
|
explicit |
Definition at line 77 of file dMatrix.cc.
References Array< T, Alloc >::elem(), DiagArray2< T >::elem(), and DiagArray2< T >::length().
|
explicit |
Definition at line 84 of file dMatrix.cc.
References Array< T, Alloc >::elem(), DiagArray2< T >::elem(), and DiagArray2< T >::length().
|
explicit |
Definition at line 91 of file dMatrix.cc.
References Array< T, Alloc >::elem(), DiagArray2< T >::elem(), and DiagArray2< T >::length().
|
explicit |
Definition at line 98 of file dMatrix.cc.
References PermMatrix::col_perm_vec(), Array< T, Alloc >::elem(), len, and PermMatrix::rows().
|
explicit |
Definition at line 109 of file dMatrix.cc.
|
explicit |
Definition at line 113 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), and Array< T, Alloc >::rows().
Matrix Matrix::abs | ( | ) | const |
Definition at line 2401 of file dMatrix.cc.
References NDArray::abs().
boolMatrix Matrix::all | ( | int | dim = -1 | ) | const |
Definition at line 2359 of file dMatrix.cc.
References NDArray::all().
boolMatrix Matrix::any | ( | int | dim = -1 | ) | const |
Definition at line 2365 of file dMatrix.cc.
References NDArray::any().
Matrix Matrix::append | ( | const ColumnVector & | a | ) | const |
Definition at line 296 of file dMatrix.cc.
References Array< T, Alloc >::cols(), insert(), Array< T, Alloc >::numel(), and Array< T, Alloc >::rows().
Matrix Matrix::append | ( | const DiagMatrix & | a | ) | const |
Definition at line 311 of file dMatrix.cc.
References Array< T, Alloc >::cols(), DiagArray2< T >::cols(), insert(), Array< T, Alloc >::rows(), and DiagArray2< T >::rows().
Definition at line 266 of file dMatrix.cc.
References Array< T, Alloc >::cols(), insert(), and Array< T, Alloc >::rows().
Definition at line 281 of file dMatrix.cc.
References Array< T, Alloc >::cols(), insert(), Array< T, Alloc >::numel(), and Array< T, Alloc >::rows().
ColumnVector Matrix::column | ( | octave_idx_type | i | ) | const |
Definition at line 423 of file dMatrix.cc.
References Array< T, Alloc >::index().
Referenced by qr< T >::insert_col(), SparseMatrix::solve(), SparseMatrix::solve(), solve(), SparseMatrix::solve(), SparseMatrix::solve(), lu< T >::update(), qr< T >::update(), and lu< T >::update_piv().
RowVector Matrix::column_max | ( | ) | const |
RowVector Matrix::column_max | ( | Array< octave_idx_type > & | index | ) | const |
Definition at line 2601 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), Array< T, Alloc >::resize(), RowVector::resize(), and Array< T, Alloc >::rows().
RowVector Matrix::column_min | ( | ) | const |
RowVector Matrix::column_min | ( | Array< octave_idx_type > & | index | ) | const |
Definition at line 2546 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), Array< T, Alloc >::resize(), RowVector::resize(), and Array< T, Alloc >::rows().
Definition at line 2371 of file dMatrix.cc.
References NDArray::cumprod().
Definition at line 2377 of file dMatrix.cc.
References NDArray::cumsum().
DET Matrix::determinant | ( | ) | const |
Definition at line 867 of file dMatrix.cc.
References determinant().
Referenced by determinant(), determinant(), determinant(), and Fdet().
DET Matrix::determinant | ( | MatrixType & | mattype, |
octave_idx_type & | info, | ||
double & | rcon, | ||
bool | calc_cond = true |
||
) | const |
Definition at line 889 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), F77_XFCN, MatrixType::Full, MatrixType::Hermitian, MatrixType::Lower, MatrixType::mark_as_unsymmetric(), MatrixType::Rectangular, Array< T, Alloc >::rows(), Array< T, Alloc >::rwdata(), base_det< T >::square(), MatrixType::type(), MatrixType::Unknown, and MatrixType::Upper.
DET Matrix::determinant | ( | octave_idx_type & | info | ) | const |
Definition at line 875 of file dMatrix.cc.
References determinant().
DET Matrix::determinant | ( | octave_idx_type & | info, |
double & | rcon, | ||
bool | calc_cond = true |
||
) | const |
Definition at line 882 of file dMatrix.cc.
References determinant().
Matrix Matrix::diag | ( | octave_idx_type | k = 0 | ) | const |
Definition at line 2407 of file dMatrix.cc.
References NDArray::diag().
Referenced by octave_matrix::diag(), and ov_range< T >::diag().
DiagMatrix Matrix::diag | ( | octave_idx_type | m, |
octave_idx_type | n | ||
) | const |
Definition at line 2413 of file dMatrix.cc.
References Array< T, Alloc >::cols(), current_liboctave_error_handler, and Array< T, Alloc >::rows().
Matrix Matrix::extract | ( | octave_idx_type | r1, |
octave_idx_type | c1, | ||
octave_idx_type | r2, | ||
octave_idx_type | c2 | ||
) | const |
Definition at line 398 of file dMatrix.cc.
References Array< T, Alloc >::index().
Referenced by Fdlmread(), pseudo_inverse(), and save_three_d().
Matrix Matrix::extract_n | ( | octave_idx_type | r1, |
octave_idx_type | c1, | ||
octave_idx_type | nr, | ||
octave_idx_type | nc | ||
) | const |
Definition at line 408 of file dMatrix.cc.
References Array< T, Alloc >::index().
Referenced by F__get_position__().
Definition at line 222 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::make_unique(), Array< T, Alloc >::rows(), and Array< T, Alloc >::xelem().
Referenced by insert().
Matrix & Matrix::fill | ( | double | val, |
octave_idx_type | r1, | ||
octave_idx_type | c1, | ||
octave_idx_type | r2, | ||
octave_idx_type | c2 | ||
) |
Definition at line 240 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::make_unique(), Array< T, Alloc >::rows(), and Array< T, Alloc >::xelem().
ComplexMatrix Matrix::fourier | ( | ) | const |
Definition at line 743 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::data(), Array< T, Alloc >::rows(), and Array< T, Alloc >::rwdata().
ComplexMatrix Matrix::fourier2d | ( | ) | const |
Definition at line 802 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::data(), Array< T, Alloc >::rows(), and Array< T, Alloc >::rwdata().
|
inline |
Definition at line 137 of file dMatrix.h.
References MArray< T >::transpose().
ComplexMatrix Matrix::ifourier | ( | ) | const |
Definition at line 772 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::data(), Array< T, Alloc >::rows(), and Array< T, Alloc >::rwdata().
ComplexMatrix Matrix::ifourier2d | ( | ) | const |
Definition at line 814 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::rows(), and Array< T, Alloc >::rwdata().
Matrix & Matrix::insert | ( | const ColumnVector & | a, |
octave_idx_type | r, | ||
octave_idx_type | c | ||
) |
Definition at line 179 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), Array< T, Alloc >::make_unique(), Array< T, Alloc >::numel(), Array< T, Alloc >::rows(), and Array< T, Alloc >::xelem().
Matrix & Matrix::insert | ( | const DiagMatrix & | a, |
octave_idx_type | r, | ||
octave_idx_type | c | ||
) |
Definition at line 198 of file dMatrix.cc.
References Array< T, Alloc >::cols(), DiagArray2< T >::cols(), DiagArray2< T >::elem(), fill(), DiagArray2< T >::length(), Array< T, Alloc >::make_unique(), Array< T, Alloc >::rows(), DiagArray2< T >::rows(), and Array< T, Alloc >::xelem().
Matrix & Matrix::insert | ( | const Matrix & | a, |
octave_idx_type | r, | ||
octave_idx_type | c | ||
) |
Matrix & Matrix::insert | ( | const RowVector & | a, |
octave_idx_type | r, | ||
octave_idx_type | c | ||
) |
Definition at line 160 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), Array< T, Alloc >::make_unique(), Array< T, Alloc >::numel(), Array< T, Alloc >::rows(), and Array< T, Alloc >::xelem().
Matrix Matrix::inverse | ( | ) | const |
Matrix Matrix::inverse | ( | MatrixType & | mattype | ) | const |
Definition at line 485 of file dMatrix.cc.
References inverse().
Matrix Matrix::inverse | ( | MatrixType & | mattype, |
octave_idx_type & | info | ||
) | const |
Definition at line 493 of file dMatrix.cc.
References inverse().
Matrix Matrix::inverse | ( | MatrixType & | mattype, |
octave_idx_type & | info, | ||
double & | rcon, | ||
bool | force = false , |
||
bool | calc_cond = true |
||
) | const |
Definition at line 648 of file dMatrix.cc.
References Matrix(), Array< T, Alloc >::columns(), MatrixType::Diagonal, Array< T, Alloc >::elem(), chol< T >::inverse(), MatrixType::ishermitian(), MatrixType::Lower, MatrixType::mark_as_unsymmetric(), chol< T >::rcond(), Array< T, Alloc >::rows(), MatrixType::type(), MatrixType::Unknown, and MatrixType::Upper.
Matrix Matrix::inverse | ( | octave_idx_type & | info | ) | const |
Definition at line 469 of file dMatrix.cc.
References inverse().
Matrix Matrix::inverse | ( | octave_idx_type & | info, |
double & | rcon, | ||
bool | force = false , |
||
bool | calc_cond = true |
||
) | const |
Definition at line 477 of file dMatrix.cc.
References inverse().
bool Matrix::issymmetric | ( | ) | const |
Definition at line 137 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), Array< T, Alloc >::issquare(), and Array< T, Alloc >::rows().
Referenced by F__eigs__().
ColumnVector Matrix::lssolve | ( | const ColumnVector & | b | ) | const |
Definition at line 2124 of file dMatrix.cc.
References lssolve().
ColumnVector Matrix::lssolve | ( | const ColumnVector & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 2133 of file dMatrix.cc.
References lssolve().
ColumnVector Matrix::lssolve | ( | const ColumnVector & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank | ||
) | const |
Definition at line 2141 of file dMatrix.cc.
References lssolve().
ColumnVector Matrix::lssolve | ( | const ColumnVector & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank, | ||
double & | rcon | ||
) | const |
Definition at line 2149 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), F77_FUNC(), F77_XFCN, Array< T, Alloc >::numel(), Array< T, Alloc >::resize(), ColumnVector::resize(), Array< T, Alloc >::rows(), Array< T, Alloc >::rwdata(), and xilaenv().
ComplexColumnVector Matrix::lssolve | ( | const ComplexColumnVector & | b | ) | const |
Definition at line 2254 of file dMatrix.cc.
References ComplexMatrix::lssolve().
ComplexColumnVector Matrix::lssolve | ( | const ComplexColumnVector & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 2264 of file dMatrix.cc.
References ComplexMatrix::lssolve().
ComplexColumnVector Matrix::lssolve | ( | const ComplexColumnVector & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank | ||
) | const |
Definition at line 2273 of file dMatrix.cc.
References ComplexMatrix::lssolve().
ComplexColumnVector Matrix::lssolve | ( | const ComplexColumnVector & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank, | ||
double & | rcon | ||
) | const |
Definition at line 2282 of file dMatrix.cc.
References ComplexMatrix::lssolve().
ComplexMatrix Matrix::lssolve | ( | const ComplexMatrix & | b | ) | const |
Definition at line 2088 of file dMatrix.cc.
References ComplexMatrix::lssolve().
ComplexMatrix Matrix::lssolve | ( | const ComplexMatrix & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 2098 of file dMatrix.cc.
References ComplexMatrix::lssolve().
ComplexMatrix Matrix::lssolve | ( | const ComplexMatrix & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank | ||
) | const |
Definition at line 2107 of file dMatrix.cc.
References ComplexMatrix::lssolve().
ComplexMatrix Matrix::lssolve | ( | const ComplexMatrix & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank, | ||
double & | rcon | ||
) | const |
Definition at line 2116 of file dMatrix.cc.
References ComplexMatrix::lssolve().
Matrix Matrix::lssolve | ( | const Matrix & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 1911 of file dMatrix.cc.
References lssolve().
Matrix Matrix::lssolve | ( | const Matrix & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank | ||
) | const |
Definition at line 1919 of file dMatrix.cc.
References lssolve().
Matrix Matrix::lssolve | ( | const Matrix & | b, |
octave_idx_type & | info, | ||
octave_idx_type & | rank, | ||
double & | rcon | ||
) | const |
Definition at line 1927 of file dMatrix.cc.
References Matrix(), Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), F77_FUNC(), F77_XFCN, Array< T, Alloc >::resize(), resize(), Array< T, Alloc >::rows(), Array< T, Alloc >::rwdata(), and xilaenv().
bool Matrix::operator!= | ( | const Matrix & | a | ) | const |
Definition at line 131 of file dMatrix.cc.
Matrix & Matrix::operator+= | ( | const DiagMatrix & | a | ) |
Definition at line 2290 of file dMatrix.cc.
References Array< T, Alloc >::cols(), DiagArray2< T >::cols(), Array< T, Alloc >::elem(), DiagArray2< T >::elem(), DiagArray2< T >::length(), Array< T, Alloc >::rows(), and DiagArray2< T >::rows().
Matrix & Matrix::operator-= | ( | const DiagMatrix & | a | ) |
Definition at line 2308 of file dMatrix.cc.
References Array< T, Alloc >::cols(), DiagArray2< T >::cols(), Array< T, Alloc >::elem(), DiagArray2< T >::elem(), DiagArray2< T >::length(), Array< T, Alloc >::rows(), and DiagArray2< T >::rows().
Definition at line 122 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::data(), mx_inline_equal(), Array< T, Alloc >::numel(), and Array< T, Alloc >::rows().
Definition at line 2383 of file dMatrix.cc.
References NDArray::prod().
Definition at line 702 of file dMatrix.cc.
References Matrix(), Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), extract(), ColumnVector::extract(), DiagMatrix::extract_diag(), DiagMatrix::inverse(), Array< T, Alloc >::numel(), Array< T, Alloc >::rows(), transpose(), and V.
Referenced by Fpinv().
double Matrix::rcond | ( | ) | const |
Definition at line 1038 of file dMatrix.cc.
References rcond().
double Matrix::rcond | ( | MatrixType & | mattype | ) | const |
Definition at line 1045 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::data(), F77_XFCN, MatrixType::Full, MatrixType::Hermitian, MatrixType::Lower, MatrixType::mark_as_rectangular(), MatrixType::mark_as_unsymmetric(), norm(), MatrixType::Permuted_Lower, MatrixType::Permuted_Upper, Array< T, Alloc >::rows(), Array< T, Alloc >::rwdata(), MatrixType::type(), MatrixType::Unknown, and MatrixType::Upper.
|
inline |
Definition at line 156 of file dMatrix.h.
References Array< T >::resize().
Referenced by coplanar_partition(), LSODE::do_integrate(), LSODE::do_integrate(), opengl_renderer::draw_patch(), opengl_renderer::draw_scatter(), EigsRealSymmetricFunc(), EigsRealSymmetricMatrix(), EigsRealSymmetricMatrixShift(), F__contourc__(), Fconvhulln(), Fdlmread(), gh_manager::figure_handle_list(), find_nonzero_elem_idx(), find_nonzero_elem_idx(), Flu(), Fsize(), gh_manager::handle_list(), tree_evaluator::ignored_fcn_outputs(), CollocWt::init(), qr< T >::init(), qrp< T >::init(), DASRT::integrate(), DASRT::integrate(), DASPK::integrate(), DASSL::integrate(), DASPK::integrate(), DASSL::integrate(), lssolve(), regexp::match(), stream_list::open_file_numbers(), and octave_class::size().
RowVector Matrix::row | ( | octave_idx_type | i | ) | const |
Definition at line 417 of file dMatrix.cc.
References Array< T, Alloc >::index().
ColumnVector Matrix::row_max | ( | ) | const |
ColumnVector Matrix::row_max | ( | Array< octave_idx_type > & | index | ) | const |
Definition at line 2491 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), Array< T, Alloc >::resize(), ColumnVector::resize(), and Array< T, Alloc >::rows().
ColumnVector Matrix::row_min | ( | ) | const |
ColumnVector Matrix::row_min | ( | Array< octave_idx_type > & | index | ) | const |
Definition at line 2436 of file dMatrix.cc.
References Array< T, Alloc >::cols(), Array< T, Alloc >::elem(), Array< T, Alloc >::resize(), ColumnVector::resize(), and Array< T, Alloc >::rows().
ColumnVector Matrix::solve | ( | const ColumnVector & | b | ) | const |
Definition at line 1841 of file dMatrix.cc.
References solve().
ColumnVector Matrix::solve | ( | const ColumnVector & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 1848 of file dMatrix.cc.
References solve().
ColumnVector Matrix::solve | ( | const ColumnVector & | b, |
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1855 of file dMatrix.cc.
References solve().
ColumnVector Matrix::solve | ( | const ColumnVector & | b, |
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1861 of file dMatrix.cc.
References solve().
ComplexColumnVector Matrix::solve | ( | const ComplexColumnVector & | b | ) | const |
Definition at line 1870 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexColumnVector Matrix::solve | ( | const ComplexColumnVector & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 1877 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexColumnVector Matrix::solve | ( | const ComplexColumnVector & | b, |
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1884 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexColumnVector Matrix::solve | ( | const ComplexColumnVector & | b, |
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1892 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexMatrix Matrix::solve | ( | const ComplexMatrix & | b | ) | const |
Definition at line 1810 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexMatrix Matrix::solve | ( | const ComplexMatrix & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 1817 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexMatrix Matrix::solve | ( | const ComplexMatrix & | b, |
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1824 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexMatrix Matrix::solve | ( | const ComplexMatrix & | b, |
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1832 of file dMatrix.cc.
References ComplexMatrix::solve().
Definition at line 1780 of file dMatrix.cc.
References solve().
Matrix Matrix::solve | ( | const Matrix & | b, |
octave_idx_type & | info | ||
) | const |
Definition at line 1788 of file dMatrix.cc.
References solve().
Matrix Matrix::solve | ( | const Matrix & | b, |
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1795 of file dMatrix.cc.
References solve().
Matrix Matrix::solve | ( | const Matrix & | b, |
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1801 of file dMatrix.cc.
References solve().
ColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ColumnVector & | b | ||
) | const |
Definition at line 1714 of file dMatrix.cc.
References solve().
ColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ColumnVector & | b, | ||
octave_idx_type & | info | ||
) | const |
Definition at line 1721 of file dMatrix.cc.
References solve().
ColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ColumnVector & | b, | ||
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1729 of file dMatrix.cc.
References solve().
ColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ColumnVector & | b, | ||
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1736 of file dMatrix.cc.
ComplexColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ComplexColumnVector & | b | ||
) | const |
Definition at line 1747 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ComplexColumnVector & | b, | ||
octave_idx_type & | info | ||
) | const |
Definition at line 1754 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ComplexColumnVector & | b, | ||
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1762 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexColumnVector Matrix::solve | ( | MatrixType & | mattype, |
const ComplexColumnVector & | b, | ||
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1770 of file dMatrix.cc.
References ComplexMatrix::solve().
ComplexMatrix Matrix::solve | ( | MatrixType & | mattype, |
const ComplexMatrix & | b | ||
) | const |
Definition at line 1648 of file dMatrix.cc.
References solve().
ComplexMatrix Matrix::solve | ( | MatrixType & | mattype, |
const ComplexMatrix & | b, | ||
octave_idx_type & | info | ||
) | const |
Definition at line 1656 of file dMatrix.cc.
References solve().
ComplexMatrix Matrix::solve | ( | MatrixType & | mattype, |
const ComplexMatrix & | b, | ||
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1664 of file dMatrix.cc.
References solve().
ComplexMatrix Matrix::solve | ( | MatrixType & | mattype, |
const ComplexMatrix & | b, | ||
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
bool | singular_fallback = true , |
||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1702 of file dMatrix.cc.
References solve().
Matrix Matrix::solve | ( | MatrixType & | mattype, |
const Matrix & | b | ||
) | const |
Definition at line 1591 of file dMatrix.cc.
References solve().
Referenced by solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), solve(), xdiv(), xdiv(), xleftdiv(), and xleftdiv().
Matrix Matrix::solve | ( | MatrixType & | mattype, |
const Matrix & | b, | ||
octave_idx_type & | info | ||
) | const |
Definition at line 1599 of file dMatrix.cc.
References solve().
Matrix Matrix::solve | ( | MatrixType & | mattype, |
const Matrix & | b, | ||
octave_idx_type & | info, | ||
double & | rcon | ||
) | const |
Definition at line 1607 of file dMatrix.cc.
References solve().
Matrix Matrix::solve | ( | MatrixType & | mattype, |
const Matrix & | b, | ||
octave_idx_type & | info, | ||
double & | rcon, | ||
solve_singularity_handler | sing_handler, | ||
bool | singular_fallback = true , |
||
blas_trans_type | transt = blas_no_trans |
||
) | const |
Definition at line 1614 of file dMatrix.cc.
References blas_conj_trans, blas_trans, MatrixType::Full, MatrixType::Hermitian, MatrixType::Lower, lssolve(), MatrixType::Permuted_Lower, MatrixType::Permuted_Upper, MatrixType::Rectangular, solve(), transpose(), MatrixType::type(), MatrixType::Unknown, and MatrixType::Upper.
Matrix Matrix::stack | ( | const ColumnVector & | a | ) | const |
Definition at line 356 of file dMatrix.cc.
References Array< T, Alloc >::cols(), insert(), Array< T, Alloc >::numel(), and Array< T, Alloc >::rows().
Matrix Matrix::stack | ( | const DiagMatrix & | a | ) | const |
Definition at line 371 of file dMatrix.cc.
References Array< T, Alloc >::cols(), DiagArray2< T >::cols(), insert(), Array< T, Alloc >::rows(), and DiagArray2< T >::rows().
Definition at line 326 of file dMatrix.cc.
References Array< T, Alloc >::cols(), insert(), and Array< T, Alloc >::rows().
Definition at line 341 of file dMatrix.cc.
References Array< T, Alloc >::cols(), insert(), Array< T, Alloc >::numel(), and Array< T, Alloc >::rows().
Definition at line 2389 of file dMatrix.cc.
References NDArray::sum().
Definition at line 2395 of file dMatrix.cc.
References NDArray::sumsq().
|
inline |
Definition at line 138 of file dMatrix.h.
References MArray< T >::transpose().
Referenced by coplanar_partition(), F__delaunayn__(), F__dsearchn__(), F__voronoi__(), Faudiowrite(), Fconvhulln(), Fordqz(), pseudo_inverse(), read_mat_binary_data(), solve(), Sylvester(), xdiv(), xdiv(), xdiv(), and xdiv().
|
friend |
|
friend |
Definition at line 392 of file dMatrix.cc.
|
friend |
Definition at line 2648 of file dMatrix.cc.
|
friend |
Definition at line 2664 of file dMatrix.cc.
|
friend |
Definition at line 386 of file dMatrix.cc.