GNU Octave  9.1.0
A high-level interpreted language, primarily intended for numerical computations, mostly compatible with Matlab
ComplexMatrix Member List

This is the complete list of members for ComplexMatrix, including all inherited members.

abs() constComplexMatrix
all(int dim=-1) constComplexMatrix
all_elements_are_real() constComplexNDArray
all_integers(double &max_val, double &min_val) constComplexNDArray
any(int dim=-1) constComplexMatrix
any_element_is_inf_or_nan() constComplexNDArray
any_element_is_nan() constComplexNDArray
append(const Matrix &a) constComplexMatrix
append(const RowVector &a) constComplexMatrix
append(const ColumnVector &a) constComplexMatrix
append(const DiagMatrix &a) constComplexMatrix
append(const ComplexMatrix &a) constComplexMatrix
append(const ComplexRowVector &a) constComplexMatrix
append(const ComplexColumnVector &a) constComplexMatrix
append(const ComplexDiagMatrix &a) constComplexMatrix
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() constArray< T, Alloc >inline
as_matrix() constArray< T, Alloc >inline
as_row() constArray< 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() constArray< T, Alloc >inline
cat(int dim, octave_idx_type n, const Array< T, Alloc > *array_list)Array< T, Alloc >static
changesign()ComplexNDArrayinline
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) constArray< T, Alloc >
checkelem(octave_idx_type i, octave_idx_type j) constArray< T, Alloc >
checkelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< T, Alloc >
checkelem(const Array< octave_idx_type > &ra_idx) constArray< 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() constArray< T, Alloc >inline
column(octave_idx_type i) constComplexMatrix
column_is_real_only(octave_idx_type) constComplexMatrix
column_max() constComplexMatrix
column_max(Array< octave_idx_type > &index) constComplexMatrix
column_min() constComplexMatrix
column_min(Array< octave_idx_type > &index) constComplexMatrix
column_vector_type typedefComplexMatrix
columns() constArray< T, Alloc >inline
compare_fcn_type typedefArray< T, Alloc >
complex_diag_matrix_type typedefComplexMatrix
complex_elt_type typedefComplexMatrix
complex_matrix_type typedefComplexMatrix
ComplexMatrix()=defaultComplexMatrix
ComplexMatrix(const ComplexMatrix &a)=defaultComplexMatrix
ComplexMatrix(octave_idx_type r, octave_idx_type c)ComplexMatrixinline
ComplexMatrix(octave_idx_type r, octave_idx_type c, const Complex &val)ComplexMatrixinline
ComplexMatrix(const dim_vector &dv)ComplexMatrixinline
ComplexMatrix(const dim_vector &dv, const Complex &val)ComplexMatrixinline
ComplexMatrix(const MArray< U > &a)ComplexMatrixinline
ComplexMatrix(const Array< U > &a)ComplexMatrixinline
ComplexMatrix(const Matrix &re, const Matrix &im)ComplexMatrix
ComplexMatrix(const Matrix &a)ComplexMatrixexplicit
ComplexMatrix(const RowVector &rv)ComplexMatrixexplicit
ComplexMatrix(const ColumnVector &cv)ComplexMatrixexplicit
ComplexMatrix(const DiagMatrix &a)ComplexMatrixexplicit
ComplexMatrix(const MDiagArray2< double > &a)ComplexMatrixexplicit
ComplexMatrix(const DiagArray2< double > &a)ComplexMatrixexplicit
ComplexMatrix(const ComplexRowVector &rv)ComplexMatrixexplicit
ComplexMatrix(const ComplexColumnVector &cv)ComplexMatrixexplicit
ComplexMatrix(const ComplexDiagMatrix &a)ComplexMatrixexplicit
ComplexMatrix(const MDiagArray2< Complex > &a)ComplexMatrixexplicit
ComplexMatrix(const DiagArray2< Complex > &a)ComplexMatrixexplicit
ComplexMatrix(const boolMatrix &a)ComplexMatrixexplicit
ComplexMatrix(const charMatrix &a)ComplexMatrixexplicit
ComplexNDArray()ComplexNDArrayinline
ComplexNDArray(const dim_vector &dv)ComplexNDArrayinline
ComplexNDArray(const dim_vector &dv, const Complex &val)ComplexNDArrayinline
ComplexNDArray(const ComplexNDArray &a)ComplexNDArrayinline
ComplexNDArray(const MArray< U > &a)ComplexNDArrayinline
ComplexNDArray(const Array< U > &a)ComplexNDArrayinline
ComplexNDArray(const charNDArray &)ComplexNDArray
compute_index(Array< octave_idx_type > &ra_idx, const dim_vector &dimensions)ComplexNDArraystatic
MArray< Complex >::compute_index(octave_idx_type i, octave_idx_type j) constArray< T, Alloc >
MArray< Complex >::compute_index(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< T, Alloc >
MArray< Complex >::compute_index(const Array< octave_idx_type > &ra_idx) constArray< T, Alloc >
compute_index_unchecked(const Array< octave_idx_type > &ra_idx) constArray< 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)ComplexMatrixfriend
crefT typedefArray< T, Alloc >
cummax(int dim=-1) constComplexNDArray
cummax(Array< octave_idx_type > &index, int dim=-1) constComplexNDArray
cummin(int dim=-1) constComplexNDArray
cummin(Array< octave_idx_type > &index, int dim=-1) constComplexNDArray
cumprod(int dim=-1) constComplexMatrix
cumsum(int dim=-1) constComplexMatrix
data() constArray< 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() constComplexMatrix
determinant(octave_idx_type &info) constComplexMatrix
determinant(octave_idx_type &info, double &rcon, bool calc_cond=true) constComplexMatrix
determinant(MatrixType &mattype, octave_idx_type &info, double &rcon, bool calc_cond=true) constComplexMatrix
diag(octave_idx_type k=0) constComplexMatrix
diag(octave_idx_type m, octave_idx_type n) constComplexMatrix
diff(octave_idx_type order=1, int dim=-1) constComplexNDArray
dim1() constArray< T, Alloc >inline
dim2() constArray< T, Alloc >inline
dim3() constArray< T, Alloc >inline
dims() constArray< 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) constArray< T, Alloc >inline
elem(octave_idx_type i, octave_idx_type j) constArray< T, Alloc >inline
elem(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< T, Alloc >inline
elem(const Array< octave_idx_type > &ra_idx) constArray< T, Alloc >inline
element_type typedefArray< T, Alloc >
extract(octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) constComplexMatrix
extract_n(octave_idx_type r1, octave_idx_type c1, octave_idx_type nr, octave_idx_type nc) constComplexMatrix
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) constArray< T, Alloc >
find(octave_idx_type, bool) constArray< T, Alloc >
find(octave_idx_type, bool) constArray< T, Alloc >
fortran_vec()Array< T, Alloc >
fourier() constComplexMatrix
ComplexNDArray::fourier(int dim=1) constComplexNDArray
fourier2d() constComplexMatrix
fourierNd() constComplexNDArray
hermitian() constComplexMatrixinline
ComplexNDArray::hermitian(Complex(*fcn)(const Complex &)=nullptr) constMArray< Complex >inline
Array::hermitian(T(*fcn)(const T &)=nullptr) constArray< 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() constComplexMatrix
ComplexNDArray::ifourier(int dim=1) constComplexNDArray
ifourier2d() constComplexMatrix
ifourierNd() constComplexNDArray
increment_index(Array< octave_idx_type > &ra_idx, const dim_vector &dimensions, int start_dimension=0)ComplexNDArraystatic
index(const octave::idx_vector &i) constArray< T, Alloc >
index(const octave::idx_vector &i, const octave::idx_vector &j) constArray< T, Alloc >
index(const Array< octave::idx_vector > &ia) constArray< T, Alloc >
index(const octave::idx_vector &i, bool resize_ok, const T &rfv) constArray< T, Alloc >
index(const octave::idx_vector &i, bool resize_ok) constArray< T, Alloc >inline
index(const octave::idx_vector &i, const octave::idx_vector &j, bool resize_ok, const T &rfv) constArray< T, Alloc >
index(const octave::idx_vector &i, const octave::idx_vector &j, bool resize_ok) constArray< T, Alloc >inline
index(const Array< octave::idx_vector > &ia, bool resize_ok, const T &rfv) constArray< T, Alloc >
index(const Array< octave::idx_vector > &ia, bool resize_ok) constArray< 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() constComplexMatrix
inverse(octave_idx_type &info) constComplexMatrix
inverse(octave_idx_type &info, double &rcon, bool force=false, bool calc_cond=true) constComplexMatrix
inverse(MatrixType &mattype) constComplexMatrix
inverse(MatrixType &mattype, octave_idx_type &info) constComplexMatrix
inverse(MatrixType &mattype, octave_idx_type &info, double &rcon, bool force=false, bool calc_cond=true) constComplexMatrix
ipermute(const Array< octave_idx_type > &vec) constMArray< Complex >inline
is_nd_vector() constArray< T, Alloc >inline
is_shared() constArray< T, Alloc >inline
is_sorted_rows(sortmode mode=UNSORTED) constArray< T, Alloc >
is_sorted_rows(sortmode) constArray< T, Alloc >
is_sorted_rows(sortmode) constArray< T, Alloc >
isempty() constArray< T, Alloc >inline
isfinite() constComplexNDArray
ishermitian() constComplexMatrix
isinf() constComplexNDArray
isnan() constComplexNDArray
issorted(sortmode mode=UNSORTED) constArray< T, Alloc >
issorted(sortmode mode) constArray< T, Alloc >
issorted(sortmode) constArray< T, Alloc >
issorted(sortmode) constArray< T, Alloc >
issquare() constArray< T, Alloc >inline
isvector() constArray< T, Alloc >inline
linear_slice(octave_idx_type lo, octave_idx_type up) constArray< T, Alloc >
lookup(const T &value, sortmode mode=UNSORTED) constArray< T, Alloc >
lookup(const Array< T, Alloc > &values, sortmode mode=UNSORTED) constArray< T, Alloc >
lookup(octave::idx_vector const &, sortmode) constArray< T, Alloc >
lookup(const Array< octave::idx_vector > &, sortmode) constArray< T, Alloc >
lookup(octave::cdef_object const &, sortmode) constArray< T, Alloc >
lookup(const Array< octave::cdef_object > &, sortmode) constArray< T, Alloc >
lssolve(const Matrix &b) constComplexMatrix
lssolve(const Matrix &b, octave_idx_type &info) constComplexMatrix
lssolve(const Matrix &b, octave_idx_type &info, octave_idx_type &rank) constComplexMatrix
lssolve(const Matrix &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) constComplexMatrix
lssolve(const ComplexMatrix &b) constComplexMatrix
lssolve(const ComplexMatrix &b, octave_idx_type &info) constComplexMatrix
lssolve(const ComplexMatrix &b, octave_idx_type &info, octave_idx_type &rank) constComplexMatrix
lssolve(const ComplexMatrix &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) constComplexMatrix
lssolve(const ColumnVector &b) constComplexMatrix
lssolve(const ColumnVector &b, octave_idx_type &info) constComplexMatrix
lssolve(const ColumnVector &b, octave_idx_type &info, octave_idx_type &rank) constComplexMatrix
lssolve(const ColumnVector &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) constComplexMatrix
lssolve(const ComplexColumnVector &b) constComplexMatrix
lssolve(const ComplexColumnVector &b, octave_idx_type &info) constComplexMatrix
lssolve(const ComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank) constComplexMatrix
lssolve(const ComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank, double &rcon) constComplexMatrix
m_dimensionsArray< T, Alloc >protected
m_repArray< T, Alloc >protected
m_slice_dataArray< T, Alloc >protected
m_slice_lenArray< T, Alloc >protected
make_unique()Array< T, Alloc >inline
map(F fcn) constArray< T, Alloc >inline
map(U(&fcn)(T)) constArray< T, Alloc >inline
map(U(&fcn)(const T &)) constArray< 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) constComplexNDArray
max(Array< octave_idx_type > &index, int dim=-1) constComplexNDArray
maybe_economize()Array< T, Alloc >inline
min(int dim=-1) constComplexNDArray
min(Array< octave_idx_type > &index, int dim=-1) constComplexNDArray
ndims() constArray< T, Alloc >inline
nnz() constArray< T, Alloc >
nnz() constArray< T, Alloc >
nnz() constArray< T, Alloc >
nth_element(const octave::idx_vector &n, int dim=0) constArray< T, Alloc >
nth_element(const octave::idx_vector &, int) constArray< T, Alloc >
nth_element(const octave::idx_vector &, int) constArray< T, Alloc >
numel() constArray< T, Alloc >inline
operator!() constComplexNDArray
operator!=(const ComplexMatrix &a) constComplexMatrix
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) constArray< T, Alloc >inline
operator()(octave_idx_type i, octave_idx_type j) constArray< T, Alloc >inline
operator()(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< T, Alloc >inline
operator()(const Array< octave_idx_type > &ra_idx) constArray< 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)ComplexMatrixfriend
operator=(const ComplexMatrix &a)=defaultComplexMatrix
ComplexNDArray::operator=(const ComplexNDArray &a)ComplexNDArrayinline
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) constComplexMatrix
operator>>(std::istream &is, ComplexMatrix &a)ComplexMatrixfriend
optimize_dimensions(const dim_vector &dv)Array< T, Alloc >
page(octave_idx_type k) constArray< T, Alloc >
pages() constArray< T, Alloc >inline
permute(const Array< octave_idx_type > &vec, bool inv=false) constMArray< Complex >inline
print_info(std::ostream &os, const std::string &prefix) constArray< T, Alloc >
prod(int dim=-1) constComplexMatrix
pseudo_inverse(double tol=0.0) constComplexMatrix
rcond() constComplexMatrix
rcond(MatrixType &mattype) constComplexMatrix
real_column_vector_type typedefComplexMatrix
real_diag_matrix_type typedefComplexMatrix
real_elt_type typedefComplexMatrix
real_matrix_type typedefComplexMatrix
real_row_vector_type typedefComplexMatrix
reshape(const dim_vector &new_dims) constMArray< Complex >inline
Array::reshape(octave_idx_type nr, octave_idx_type nc) constArray< T, Alloc >inline
resize(octave_idx_type nr, octave_idx_type nc, const Complex &rfv=Complex(0))ComplexMatrixinline
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() constArray< T, Alloc >virtual
row(octave_idx_type i) constComplexMatrix
row_is_real_only(octave_idx_type) constComplexMatrix
row_max() constComplexMatrix
row_max(Array< octave_idx_type > &index) constComplexMatrix
row_min() constComplexMatrix
row_min(Array< octave_idx_type > &index) constComplexMatrix
row_vector_type typedefComplexMatrix
rows() constArray< T, Alloc >inline
size(const size_type d) constArray< T, Alloc >inline
size_type typedefArray< T, Alloc >
solve(MatrixType &mattype, const Matrix &b) constComplexMatrix
solve(MatrixType &mattype, const Matrix &b, octave_idx_type &info) constComplexMatrix
solve(MatrixType &mattype, const Matrix &b, octave_idx_type &info, double &rcon) constComplexMatrix
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) constComplexMatrix
solve(MatrixType &mattype, const ComplexMatrix &b) constComplexMatrix
solve(MatrixType &mattype, const ComplexMatrix &b, octave_idx_type &info) constComplexMatrix
solve(MatrixType &mattype, const ComplexMatrix &b, octave_idx_type &info, double &rcon) constComplexMatrix
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) constComplexMatrix
solve(MatrixType &mattype, const ColumnVector &b) constComplexMatrix
solve(MatrixType &mattype, const ColumnVector &b, octave_idx_type &info) constComplexMatrix
solve(MatrixType &mattype, const ColumnVector &b, octave_idx_type &info, double &rcon) constComplexMatrix
solve(MatrixType &mattype, const ColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) constComplexMatrix
solve(MatrixType &mattype, const ComplexColumnVector &b) constComplexMatrix
solve(MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info) constComplexMatrix
solve(MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info, double &rcon) constComplexMatrix
solve(MatrixType &mattype, const ComplexColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) constComplexMatrix
solve(const Matrix &b) constComplexMatrix
solve(const Matrix &b, octave_idx_type &info) constComplexMatrix
solve(const Matrix &b, octave_idx_type &info, double &rcon) constComplexMatrix
solve(const Matrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) constComplexMatrix
solve(const ComplexMatrix &b) constComplexMatrix
solve(const ComplexMatrix &b, octave_idx_type &info) constComplexMatrix
solve(const ComplexMatrix &b, octave_idx_type &info, double &rcon) constComplexMatrix
solve(const ComplexMatrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) constComplexMatrix
solve(const ColumnVector &b) constComplexMatrix
solve(const ColumnVector &b, octave_idx_type &info) constComplexMatrix
solve(const ColumnVector &b, octave_idx_type &info, double &rcon) constComplexMatrix
solve(const ColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) constComplexMatrix
solve(const ComplexColumnVector &b) constComplexMatrix
solve(const ComplexColumnVector &b, octave_idx_type &info) constComplexMatrix
solve(const ComplexColumnVector &b, octave_idx_type &info, double &rcon) constComplexMatrix
solve(const ComplexColumnVector &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) constComplexMatrix
solve_singularity_handler typedefComplexMatrix
sort(int dim=0, sortmode mode=ASCENDING) constArray< T, Alloc >
sort(Array< octave_idx_type > &sidx, int dim=0, sortmode mode=ASCENDING) constArray< T, Alloc >
sort(int, sortmode) constArray< T, Alloc >
sort(Array< octave_idx_type > &sidx, int, sortmode) constArray< T, Alloc >
sort(int, sortmode) constArray< T, Alloc >
sort(Array< octave_idx_type > &sidx, int, sortmode) constArray< T, Alloc >
sort_rows_idx(sortmode mode=ASCENDING) constArray< T, Alloc >
sort_rows_idx(sortmode) constArray< T, Alloc >
sort_rows_idx(sortmode) constArray< T, Alloc >
squeeze() constComplexNDArrayinline
stack(const Matrix &a) constComplexMatrix
stack(const RowVector &a) constComplexMatrix
stack(const ColumnVector &a) constComplexMatrix
stack(const DiagMatrix &a) constComplexMatrix
stack(const ComplexMatrix &a) constComplexMatrix
stack(const ComplexRowVector &a) constComplexMatrix
stack(const ComplexColumnVector &a) constComplexMatrix
stack(const ComplexDiagMatrix &a) constComplexMatrix
sum(int dim=-1) constComplexMatrix
sumsq(int dim=-1) constComplexMatrix
test(F fcn) constArray< T, Alloc >inline
test_all(F fcn) constArray< T, Alloc >inline
test_all(bool(&fcn)(T)) constArray< T, Alloc >inline
test_all(bool(&fcn)(const T &)) constArray< T, Alloc >inline
test_any(F fcn) constArray< T, Alloc >inline
test_any(bool(&fcn)(T)) constArray< T, Alloc >inline
test_any(bool(&fcn)(const T &)) constArray< T, Alloc >inline
too_large_for_float() constComplexNDArray
transpose() constComplexMatrixinline
value_type typedefArray< T, Alloc >
xelem(octave_idx_type n)Array< T, Alloc >inline
xelem(octave_idx_type n) constArray< 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) constArray< 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) constArray< T, Alloc >inline
xelem(const Array< octave_idx_type > &ra_idx)Array< T, Alloc >inline
xelem(const Array< octave_idx_type > &ra_idx) constArray< T, Alloc >inline
xsum(int dim=-1) constComplexNDArray
~Array()Array< T, Alloc >inlinevirtual
~ComplexMatrix()=defaultComplexMatrix
~ComplexNDArray()=defaultComplexNDArray
~MArray()=defaultMArray< Complex >