This is the complete list of members for ComplexMatrix, including all inherited members.
abs() const | ComplexMatrix | |
all(int dim=-1) const | ComplexMatrix | |
all_elements_are_real() const | ComplexNDArray | |
all_integers(double &max_val, double &min_val) const | ComplexNDArray | |
any(int dim=-1) const | ComplexMatrix | |
any_element_is_inf_or_nan() const | ComplexNDArray | |
any_element_is_nan() const | ComplexNDArray | |
append(const Matrix &a) const | ComplexMatrix | |
append(const RowVector &a) const | ComplexMatrix | |
append(const ColumnVector &a) const | ComplexMatrix | |
append(const DiagMatrix &a) const | ComplexMatrix | |
append(const ComplexMatrix &a) const | ComplexMatrix | |
append(const ComplexRowVector &a) const | ComplexMatrix | |
append(const ComplexColumnVector &a) const | ComplexMatrix | |
append(const ComplexDiagMatrix &a) const | ComplexMatrix | |
Array(const Array< T, Alloc > &a, const dim_vector &dv, octave_idx_type l, octave_idx_type u) | Array< T, Alloc > | inlineprotected |
Array() | Array< T, Alloc > | inline |
Array(const dim_vector &dv) | Array< T, Alloc > | inlineexplicit |
Array(const dim_vector &dv, const T &val) | Array< T, Alloc > | inlineexplicit |
Array(T *ptr, const dim_vector &dv, const Alloc &xallocator=Alloc()) | Array< T, Alloc > | inlineexplicit |
Array(const Array< T, Alloc > &a, const dim_vector &dv) | Array< T, Alloc > | |
Array(const Container< T > &a, const dim_vector &dv) | Array< T, Alloc > | |
Array(const Array< U, A > &a) | Array< T, Alloc > | inline |
Array(const Array< T, Alloc > &a) | Array< T, Alloc > | inline |
Array(Array< T, Alloc > &&a) | Array< T, Alloc > | inline |
as_column() const | Array< T, Alloc > | inline |
as_matrix() const | Array< T, Alloc > | inline |
as_row() const | Array< T, Alloc > | inline |
assign(const octave::idx_vector &i, const Array< T, Alloc > &rhs, const T &rfv) | Array< T, Alloc > | |
assign(const octave::idx_vector &i, const Array< T, Alloc > &rhs) | Array< T, Alloc > | inline |
assign(const octave::idx_vector &i, const octave::idx_vector &j, const Array< T, Alloc > &rhs, const T &rfv) | Array< T, Alloc > | |
assign(const octave::idx_vector &i, const octave::idx_vector &j, const Array< T, Alloc > &rhs) | Array< T, Alloc > | inline |
assign(const Array< octave::idx_vector > &ia, const Array< T, Alloc > &rhs, const T &rfv) | Array< T, Alloc > | |
assign(const Array< octave::idx_vector > &ia, const Array< T, Alloc > &rhs) | Array< T, Alloc > | inline |
byte_size() const | Array< T, Alloc > | inline |
cat(int dim, octave_idx_type n, const Array< T, Alloc > *array_list) | Array< T, Alloc > | static |
changesign() | ComplexNDArray | inline |
checkelem(octave_idx_type n) | Array< T, Alloc > | |
checkelem(octave_idx_type i, octave_idx_type j) | Array< T, Alloc > | |
checkelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T, Alloc > | |
checkelem(const Array< octave_idx_type > &ra_idx) | Array< T, Alloc > | |
checkelem(octave_idx_type n) const | Array< T, Alloc > | |
checkelem(octave_idx_type i, octave_idx_type j) const | Array< T, Alloc > | |
checkelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T, Alloc > | |
checkelem(const Array< octave_idx_type > &ra_idx) const | Array< T, Alloc > | |
clear() | Array< T, Alloc > | |
clear(const dim_vector &dv) | Array< T, Alloc > | |
clear(octave_idx_type r, octave_idx_type c) | Array< T, Alloc > | inline |
cols() const | Array< T, Alloc > | inline |
column(octave_idx_type i) const | ComplexMatrix | |
column_is_real_only(octave_idx_type) const | ComplexMatrix | |
column_max() const | ComplexMatrix | |
column_max(Array< octave_idx_type > &index) const | ComplexMatrix | |
column_min() const | ComplexMatrix | |
column_min(Array< octave_idx_type > &index) const | ComplexMatrix | |
column_vector_type typedef | ComplexMatrix | |
columns() const | Array< T, Alloc > | inline |
compare_fcn_type typedef | Array< T, Alloc > | |
complex_diag_matrix_type typedef | ComplexMatrix | |
complex_elt_type typedef | ComplexMatrix | |
complex_matrix_type typedef | ComplexMatrix | |
ComplexMatrix()=default | ComplexMatrix | |
ComplexMatrix(const ComplexMatrix &a)=default | ComplexMatrix | |
ComplexMatrix(octave_idx_type r, octave_idx_type c) | ComplexMatrix | inline |
ComplexMatrix(octave_idx_type r, octave_idx_type c, const Complex &val) | ComplexMatrix | inline |
ComplexMatrix(const dim_vector &dv) | ComplexMatrix | inline |
ComplexMatrix(const dim_vector &dv, const Complex &val) | ComplexMatrix | inline |
ComplexMatrix(const MArray< U > &a) | ComplexMatrix | inline |
ComplexMatrix(const Array< U > &a) | ComplexMatrix | inline |
ComplexMatrix(const Matrix &re, const Matrix &im) | ComplexMatrix | |
ComplexMatrix(const Matrix &a) | ComplexMatrix | explicit |
ComplexMatrix(const RowVector &rv) | ComplexMatrix | explicit |
ComplexMatrix(const ColumnVector &cv) | ComplexMatrix | explicit |
ComplexMatrix(const DiagMatrix &a) | ComplexMatrix | explicit |
ComplexMatrix(const MDiagArray2< double > &a) | ComplexMatrix | explicit |
ComplexMatrix(const DiagArray2< double > &a) | ComplexMatrix | explicit |
ComplexMatrix(const ComplexRowVector &rv) | ComplexMatrix | explicit |
ComplexMatrix(const ComplexColumnVector &cv) | ComplexMatrix | explicit |
ComplexMatrix(const ComplexDiagMatrix &a) | ComplexMatrix | explicit |
ComplexMatrix(const MDiagArray2< Complex > &a) | ComplexMatrix | explicit |
ComplexMatrix(const DiagArray2< Complex > &a) | ComplexMatrix | explicit |
ComplexMatrix(const boolMatrix &a) | ComplexMatrix | explicit |
ComplexMatrix(const charMatrix &a) | ComplexMatrix | explicit |
ComplexNDArray() | ComplexNDArray | inline |
ComplexNDArray(const dim_vector &dv) | ComplexNDArray | inline |
ComplexNDArray(const dim_vector &dv, const Complex &val) | ComplexNDArray | inline |
ComplexNDArray(const ComplexNDArray &a) | ComplexNDArray | inline |
ComplexNDArray(const MArray< U > &a) | ComplexNDArray | inline |
ComplexNDArray(const Array< U > &a) | ComplexNDArray | inline |
ComplexNDArray(const charNDArray &) | ComplexNDArray | |
compute_index(Array< octave_idx_type > &ra_idx, const dim_vector &dimensions) | ComplexNDArray | static |
MArray< Complex >::compute_index(octave_idx_type i, octave_idx_type j) const | Array< T, Alloc > | |
MArray< Complex >::compute_index(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T, Alloc > | |
MArray< Complex >::compute_index(const Array< octave_idx_type > &ra_idx) const | Array< T, Alloc > | |
compute_index_unchecked(const Array< octave_idx_type > &ra_idx) const | Array< T, Alloc > | inline |
concat(const ComplexNDArray &rb, const Array< octave_idx_type > &ra_idx) | ComplexNDArray | |
concat(const NDArray &rb, const Array< octave_idx_type > &ra_idx) | ComplexNDArray | |
conj(const ComplexMatrix &a) | ComplexMatrix | friend |
crefT typedef | Array< T, Alloc > | |
cummax(int dim=-1) const | ComplexNDArray | |
cummax(Array< octave_idx_type > &index, int dim=-1) const | ComplexNDArray | |
cummin(int dim=-1) const | ComplexNDArray | |
cummin(Array< octave_idx_type > &index, int dim=-1) const | ComplexNDArray | |
cumprod(int dim=-1) const | ComplexMatrix | |
cumsum(int dim=-1) const | ComplexMatrix | |
data() const | Array< T, Alloc > | inline |
delete_elements(const octave::idx_vector &i) | Array< T, Alloc > | |
delete_elements(int dim, const octave::idx_vector &i) | Array< T, Alloc > | |
delete_elements(const Array< octave::idx_vector > &ia) | Array< T, Alloc > | |
determinant() const | ComplexMatrix | |
determinant(octave_idx_type &info) const | ComplexMatrix | |
determinant(octave_idx_type &info, double &rcon, bool calc_cond=true) const | ComplexMatrix | |
determinant(MatrixType &mattype, octave_idx_type &info, double &rcon, bool calc_cond=true) const | ComplexMatrix | |
diag(octave_idx_type k=0) const | ComplexMatrix | |
diag(octave_idx_type m, octave_idx_type n) const | ComplexMatrix | |
diff(octave_idx_type order=1, int dim=-1) const | ComplexNDArray | |
dim1() const | Array< T, Alloc > | inline |
dim2() const | Array< T, Alloc > | inline |
dim3() const | Array< T, Alloc > | inline |
dims() const | Array< T, Alloc > | inline |
elem(octave_idx_type n) | Array< T, Alloc > | inline |
elem(octave_idx_type i, octave_idx_type j) | Array< T, Alloc > | inline |
elem(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T, Alloc > | inline |
elem(const Array< octave_idx_type > &ra_idx) | Array< T, Alloc > | inline |
elem(octave_idx_type n) const | Array< T, Alloc > | inline |
elem(octave_idx_type i, octave_idx_type j) const | Array< T, Alloc > | inline |
elem(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T, Alloc > | inline |
elem(const Array< octave_idx_type > &ra_idx) const | Array< T, Alloc > | inline |
element_type typedef | Array< T, Alloc > | |
extract(octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) const | ComplexMatrix | |
extract_n(octave_idx_type r1, octave_idx_type c1, octave_idx_type nr, octave_idx_type nc) const | ComplexMatrix | |
fill(double val) | ComplexMatrix | |
fill(const Complex &val) | ComplexMatrix | |
fill(double val, octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) | ComplexMatrix | |
fill(const Complex &val, octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) | ComplexMatrix | |
ComplexNDArray::fill(const T &val) | Array< T, Alloc > | |
find(octave_idx_type n=-1, bool backward=false) const | Array< T, Alloc > | |
find(octave_idx_type, bool) const | Array< T, Alloc > | |
find(octave_idx_type, bool) const | Array< T, Alloc > | |
fortran_vec() | Array< T, Alloc > | |
fourier() const | ComplexMatrix | |
ComplexNDArray::fourier(int dim=1) const | ComplexNDArray | |
fourier2d() const | ComplexMatrix | |
fourierNd() const | ComplexNDArray | |
hermitian() const | ComplexMatrix | inline |
ComplexNDArray::hermitian(Complex(*fcn)(const Complex &)=nullptr) const | MArray< Complex > | inline |
Array::hermitian(T(*fcn)(const T &)=nullptr) const | Array< T, Alloc > | |
idx_add(const octave::idx_vector &idx, Complex val) | MArray< Complex > | |
idx_add(const octave::idx_vector &idx, const MArray< Complex > &vals) | MArray< Complex > | |
idx_add_nd(const octave::idx_vector &idx, const MArray< Complex > &vals, int dim=-1) | MArray< Complex > | |
idx_max(const octave::idx_vector &idx, const MArray< Complex > &vals) | MArray< Complex > | |
idx_min(const octave::idx_vector &idx, const MArray< Complex > &vals) | MArray< Complex > | |
ifourier() const | ComplexMatrix | |
ComplexNDArray::ifourier(int dim=1) const | ComplexNDArray | |
ifourier2d() const | ComplexMatrix | |
ifourierNd() const | ComplexNDArray | |
increment_index(Array< octave_idx_type > &ra_idx, const dim_vector &dimensions, int start_dimension=0) | ComplexNDArray | static |
index(const octave::idx_vector &i) const | Array< T, Alloc > | |
index(const octave::idx_vector &i, const octave::idx_vector &j) const | Array< T, Alloc > | |
index(const Array< octave::idx_vector > &ia) const | Array< T, Alloc > | |
index(const octave::idx_vector &i, bool resize_ok, const T &rfv) const | Array< T, Alloc > | |
index(const octave::idx_vector &i, bool resize_ok) const | Array< T, Alloc > | inline |
index(const octave::idx_vector &i, const octave::idx_vector &j, bool resize_ok, const T &rfv) const | Array< T, Alloc > | |
index(const octave::idx_vector &i, const octave::idx_vector &j, bool resize_ok) const | Array< T, Alloc > | inline |
index(const Array< octave::idx_vector > &ia, bool resize_ok, const T &rfv) const | Array< T, Alloc > | |
index(const Array< octave::idx_vector > &ia, bool resize_ok) const | Array< T, Alloc > | inline |
insert(const Matrix &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
insert(const RowVector &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
insert(const ColumnVector &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
insert(const DiagMatrix &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
insert(const ComplexMatrix &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
insert(const ComplexRowVector &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
insert(const ComplexColumnVector &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
insert(const ComplexDiagMatrix &a, octave_idx_type r, octave_idx_type c) | ComplexMatrix | |
ComplexNDArray::insert(const NDArray &a, octave_idx_type r, octave_idx_type c) | ComplexNDArray | |
ComplexNDArray::insert(const ComplexNDArray &a, octave_idx_type r, octave_idx_type c) | ComplexNDArray | |
ComplexNDArray::insert(const ComplexNDArray &a, const Array< octave_idx_type > &ra_idx) | ComplexNDArray | |
MArray< Complex >::insert(const Array< T, Alloc > &a, const Array< octave_idx_type > &idx) | Array< T, Alloc > | |
MArray< Complex >::insert(const Array< T, Alloc > &a, octave_idx_type r, octave_idx_type c) | Array< T, Alloc > | |
inverse() const | ComplexMatrix | |
inverse(octave_idx_type &info) const | ComplexMatrix | |
inverse(octave_idx_type &info, double &rcon, bool force=false, bool calc_cond=true) const | ComplexMatrix | |
inverse(MatrixType &mattype) const | ComplexMatrix | |
inverse(MatrixType &mattype, octave_idx_type &info) const | ComplexMatrix | |
inverse(MatrixType &mattype, octave_idx_type &info, double &rcon, bool force=false, bool calc_cond=true) const | ComplexMatrix | |
ipermute(const Array< octave_idx_type > &vec) const | MArray< Complex > | inline |
is_nd_vector() const | Array< T, Alloc > | inline |
is_shared() const | Array< T, Alloc > | inline |
is_sorted_rows(sortmode mode=UNSORTED) const | Array< T, Alloc > | |
is_sorted_rows(sortmode) const | Array< T, Alloc > | |
is_sorted_rows(sortmode) const | Array< T, Alloc > | |
isempty() const | Array< T, Alloc > | inline |
isfinite() const | ComplexNDArray | |
ishermitian() const | ComplexMatrix | |
isinf() const | ComplexNDArray | |
isnan() const | ComplexNDArray | |
issorted(sortmode mode=UNSORTED) const | Array< T, Alloc > | |
issorted(sortmode mode) const | Array< T, Alloc > | |
issorted(sortmode) const | Array< T, Alloc > | |
issorted(sortmode) const | Array< T, Alloc > | |
issquare() const | Array< T, Alloc > | inline |
isvector() const | Array< T, Alloc > | inline |
linear_slice(octave_idx_type lo, octave_idx_type up) const | Array< T, Alloc > | |
lookup(const T &value, sortmode mode=UNSORTED) const | Array< T, Alloc > | |
lookup(const Array< T, Alloc > &values, sortmode mode=UNSORTED) const | Array< T, Alloc > | |
lookup(octave::idx_vector const &, sortmode) const | Array< T, Alloc > | |
lookup(const Array< octave::idx_vector > &, sortmode) const | Array< T, Alloc > | |
lookup(octave::cdef_object const &, sortmode) const | Array< T, Alloc > | |
lookup(const Array< octave::cdef_object > &, sortmode) const | Array< T, Alloc > | |
lssolve(const Matrix &b) const | ComplexMatrix | |
lssolve(const Matrix &b, octave_idx_type &info) const | ComplexMatrix | |
lssolve(const Matrix &b, octave_idx_type &info, octave_idx_type &rank) const | ComplexMatrix | |
lssolve(const Matrix &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 | ComplexMatrix | |
lssolve(const ColumnVector &b) const | ComplexMatrix | |
lssolve(const ColumnVector &b, octave_idx_type &info) const | ComplexMatrix | |
lssolve(const ColumnVector &b, octave_idx_type &info, octave_idx_type &rank) const | ComplexMatrix | |
lssolve(const ColumnVector &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) const | ComplexMatrix | |
lssolve(const ComplexColumnVector &b) const | ComplexMatrix | |
lssolve(const ComplexColumnVector &b, octave_idx_type &info) const | ComplexMatrix | |
lssolve(const ComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank) const | ComplexMatrix | |
lssolve(const ComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) const | ComplexMatrix | |
m_dimensions | Array< T, Alloc > | protected |
m_rep | Array< T, Alloc > | protected |
m_slice_data | Array< T, Alloc > | protected |
m_slice_len | Array< T, Alloc > | protected |
make_unique() | Array< T, Alloc > | inline |
map(F fcn) const | Array< T, Alloc > | inline |
map(U(&fcn)(T)) const | Array< T, Alloc > | inline |
map(U(&fcn)(const T &)) const | Array< T, Alloc > | inline |
MArray() | MArray< Complex > | inline |
MArray(const dim_vector &dv) | MArray< Complex > | inlineexplicit |
MArray(const dim_vector &dv, const Complex &val) | MArray< Complex > | inlineexplicit |
MArray(const MArray< Complex > &a) | MArray< Complex > | inline |
MArray(const Array< U > &a) | MArray< Complex > | inline |
max(int dim=-1) const | ComplexNDArray | |
max(Array< octave_idx_type > &index, int dim=-1) const | ComplexNDArray | |
maybe_economize() | Array< T, Alloc > | inline |
min(int dim=-1) const | ComplexNDArray | |
min(Array< octave_idx_type > &index, int dim=-1) const | ComplexNDArray | |
ndims() const | Array< T, Alloc > | inline |
nnz() const | Array< T, Alloc > | |
nnz() const | Array< T, Alloc > | |
nnz() const | Array< T, Alloc > | |
nth_element(const octave::idx_vector &n, int dim=0) const | Array< T, Alloc > | |
nth_element(const octave::idx_vector &, int) const | Array< T, Alloc > | |
nth_element(const octave::idx_vector &, int) const | Array< T, Alloc > | |
numel() const | Array< T, Alloc > | inline |
operator!() const | ComplexNDArray | |
operator!=(const ComplexMatrix &a) const | ComplexMatrix | |
operator()(octave_idx_type n) | Array< T, Alloc > | inline |
operator()(octave_idx_type i, octave_idx_type j) | Array< T, Alloc > | inline |
operator()(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T, Alloc > | inline |
operator()(const Array< octave_idx_type > &ra_idx) | Array< T, Alloc > | inline |
operator()(octave_idx_type n) const | Array< T, Alloc > | inline |
operator()(octave_idx_type i, octave_idx_type j) const | Array< T, Alloc > | inline |
operator()(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T, Alloc > | inline |
operator()(const Array< octave_idx_type > &ra_idx) const | Array< T, Alloc > | inline |
operator+=(const DiagMatrix &a) | ComplexMatrix | |
operator+=(const ComplexDiagMatrix &a) | ComplexMatrix | |
operator+=(const Matrix &a) | ComplexMatrix | |
operator-=(const DiagMatrix &a) | ComplexMatrix | |
operator-=(const ComplexDiagMatrix &a) | ComplexMatrix | |
operator-=(const Matrix &a) | ComplexMatrix | |
operator<<(std::ostream &os, const ComplexMatrix &a) | ComplexMatrix | friend |
operator=(const ComplexMatrix &a)=default | ComplexMatrix | |
ComplexNDArray::operator=(const ComplexNDArray &a) | ComplexNDArray | inline |
MArray< Complex >::operator=(const MArray< Complex > &a) | MArray< Complex > | inline |
Array::operator=(const Array< T, Alloc > &a) | Array< T, Alloc > | inline |
Array::operator=(Array< T, Alloc > &&a) | Array< T, Alloc > | inline |
operator==(const ComplexMatrix &a) const | ComplexMatrix | |
operator>>(std::istream &is, ComplexMatrix &a) | ComplexMatrix | friend |
optimize_dimensions(const dim_vector &dv) | Array< T, Alloc > | |
page(octave_idx_type k) const | Array< T, Alloc > | |
pages() const | Array< T, Alloc > | inline |
permute(const Array< octave_idx_type > &vec, bool inv=false) const | MArray< Complex > | inline |
print_info(std::ostream &os, const std::string &prefix) const | Array< T, Alloc > | |
prod(int dim=-1) const | ComplexMatrix | |
pseudo_inverse(double tol=0.0) const | ComplexMatrix | |
rcond() const | ComplexMatrix | |
rcond(MatrixType &mattype) const | ComplexMatrix | |
real_column_vector_type typedef | ComplexMatrix | |
real_diag_matrix_type typedef | ComplexMatrix | |
real_elt_type typedef | ComplexMatrix | |
real_matrix_type typedef | ComplexMatrix | |
real_row_vector_type typedef | ComplexMatrix | |
reshape(const dim_vector &new_dims) const | MArray< Complex > | inline |
Array::reshape(octave_idx_type nr, octave_idx_type nc) const | Array< T, Alloc > | inline |
resize(octave_idx_type nr, octave_idx_type nc, const Complex &rfv=Complex(0)) | ComplexMatrix | inline |
ComplexNDArray::resize(const dim_vector &dv, const T &rfv) | Array< T, Alloc > | |
ComplexNDArray::resize(const dim_vector &dv) | Array< T, Alloc > | inline |
resize1(octave_idx_type n, const T &rfv) | Array< T, Alloc > | |
resize1(octave_idx_type n) | Array< T, Alloc > | inline |
resize2(octave_idx_type nr, octave_idx_type nc, const T &rfv) | Array< T, Alloc > | |
resize2(octave_idx_type nr, octave_idx_type nc) | Array< T, Alloc > | inline |
resize_fill_value() const | Array< T, Alloc > | virtual |
row(octave_idx_type i) const | ComplexMatrix | |
row_is_real_only(octave_idx_type) const | ComplexMatrix | |
row_max() const | ComplexMatrix | |
row_max(Array< octave_idx_type > &index) const | ComplexMatrix | |
row_min() const | ComplexMatrix | |
row_min(Array< octave_idx_type > &index) const | ComplexMatrix | |
row_vector_type typedef | ComplexMatrix | |
rows() const | Array< T, Alloc > | inline |
size(const size_type d) const | Array< T, Alloc > | inline |
size_type typedef | Array< T, Alloc > | |
solve(MatrixType &mattype, const Matrix &b) const | ComplexMatrix | |
solve(MatrixType &mattype, const Matrix &b, octave_idx_type &info) const | ComplexMatrix | |
solve(MatrixType &mattype, const Matrix &b, octave_idx_type &info, double &rcon) const | ComplexMatrix | |
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 | 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 | ComplexMatrix | |
solve(MatrixType &mattype, const ColumnVector &b) const | ComplexMatrix | |
solve(MatrixType &mattype, const ColumnVector &b, octave_idx_type &info) const | ComplexMatrix | |
solve(MatrixType &mattype, const ColumnVector &b, octave_idx_type &info, double &rcon) const | ComplexMatrix | |
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 | ComplexMatrix | |
solve(MatrixType &mattype, const ComplexColumnVector &b) const | ComplexMatrix | |
solve(MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info) const | ComplexMatrix | |
solve(MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info, double &rcon) const | ComplexMatrix | |
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(const Matrix &b) const | ComplexMatrix | |
solve(const Matrix &b, octave_idx_type &info) const | ComplexMatrix | |
solve(const Matrix &b, octave_idx_type &info, double &rcon) const | ComplexMatrix | |
solve(const Matrix &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 | ComplexMatrix | |
solve(const ColumnVector &b) const | ComplexMatrix | |
solve(const ColumnVector &b, octave_idx_type &info) const | ComplexMatrix | |
solve(const ColumnVector &b, octave_idx_type &info, double &rcon) const | ComplexMatrix | |
solve(const ColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const | ComplexMatrix | |
solve(const ComplexColumnVector &b) const | ComplexMatrix | |
solve(const ComplexColumnVector &b, octave_idx_type &info) const | ComplexMatrix | |
solve(const ComplexColumnVector &b, octave_idx_type &info, double &rcon) const | ComplexMatrix | |
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_singularity_handler typedef | ComplexMatrix | |
sort(int dim=0, sortmode mode=ASCENDING) const | Array< T, Alloc > | |
sort(Array< octave_idx_type > &sidx, int dim=0, sortmode mode=ASCENDING) const | Array< T, Alloc > | |
sort(int, sortmode) const | Array< T, Alloc > | |
sort(Array< octave_idx_type > &sidx, int, sortmode) const | Array< T, Alloc > | |
sort(int, sortmode) const | Array< T, Alloc > | |
sort(Array< octave_idx_type > &sidx, int, sortmode) const | Array< T, Alloc > | |
sort_rows_idx(sortmode mode=ASCENDING) const | Array< T, Alloc > | |
sort_rows_idx(sortmode) const | Array< T, Alloc > | |
sort_rows_idx(sortmode) const | Array< T, Alloc > | |
squeeze() const | ComplexNDArray | inline |
stack(const Matrix &a) const | ComplexMatrix | |
stack(const RowVector &a) const | ComplexMatrix | |
stack(const ColumnVector &a) const | ComplexMatrix | |
stack(const DiagMatrix &a) const | ComplexMatrix | |
stack(const ComplexMatrix &a) const | ComplexMatrix | |
stack(const ComplexRowVector &a) const | ComplexMatrix | |
stack(const ComplexColumnVector &a) const | ComplexMatrix | |
stack(const ComplexDiagMatrix &a) const | ComplexMatrix | |
sum(int dim=-1) const | ComplexMatrix | |
sumsq(int dim=-1) const | ComplexMatrix | |
test(F fcn) const | Array< T, Alloc > | inline |
test_all(F fcn) const | Array< T, Alloc > | inline |
test_all(bool(&fcn)(T)) const | Array< T, Alloc > | inline |
test_all(bool(&fcn)(const T &)) const | Array< T, Alloc > | inline |
test_any(F fcn) const | Array< T, Alloc > | inline |
test_any(bool(&fcn)(T)) const | Array< T, Alloc > | inline |
test_any(bool(&fcn)(const T &)) const | Array< T, Alloc > | inline |
too_large_for_float() const | ComplexNDArray | |
transpose() const | ComplexMatrix | inline |
value_type typedef | Array< T, Alloc > | |
xelem(octave_idx_type n) | Array< T, Alloc > | inline |
xelem(octave_idx_type n) const | Array< T, Alloc > | inline |
xelem(octave_idx_type i, octave_idx_type j) | Array< T, Alloc > | inline |
xelem(octave_idx_type i, octave_idx_type j) const | Array< T, Alloc > | inline |
xelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T, Alloc > | inline |
xelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T, Alloc > | inline |
xelem(const Array< octave_idx_type > &ra_idx) | Array< T, Alloc > | inline |
xelem(const Array< octave_idx_type > &ra_idx) const | Array< T, Alloc > | inline |
xsum(int dim=-1) const | ComplexNDArray | |
~Array() | Array< T, Alloc > | inlinevirtual |
~ComplexMatrix()=default | ComplexMatrix | |
~ComplexNDArray()=default | ComplexNDArray | |
~MArray()=default | MArray< Complex > |