GNU Octave  3.8.0
A high-level interpreted language, primarily intended for numerical computations, mostly compatible with Matlab
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
ComplexMatrix Member List

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

abs(void) const ComplexMatrix
all(int dim=-1) const ComplexMatrix
all_elements_are_real(void) const ComplexMatrix
all_integers(double &max_val, double &min_val) const ComplexMatrix
any(int dim=-1) const ComplexMatrix
any_element_is_inf_or_nan(void) const ComplexMatrix
any_element_is_nan(void) const ComplexMatrix
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< Complex > &a, const dim_vector &dv, octave_idx_type l, octave_idx_type u)Array< Complex >inlineprotected
Array(Complex *sdata, octave_idx_type slen, octave_idx_type *adims, void *arep)Array< Complex >inlineprotected
Array(void)Array< Complex >inline
Array(octave_idx_type n) GCC_ATTR_DEPRECATEDArray< Complex >inlineexplicit
Array(octave_idx_type n, const Complex &val) GCC_ATTR_DEPRECATEDArray< Complex >inlineexplicit
Array(const dim_vector &dv)Array< Complex >inlineexplicit
Array(const dim_vector &dv, const Complex &val)Array< Complex >inlineexplicit
Array(const Array< Complex > &a, const dim_vector &dv)Array< Complex >
Array(const Array< U > &a)Array< Complex >inline
Array(const Array< Complex > &a)Array< Complex >inline
as_column(void) constArray< Complex >inline
as_matrix(void) constArray< Complex >inline
as_row(void) constArray< Complex >inline
assign(const idx_vector &i, const Array< Complex > &rhs, const Complex &rfv)Array< Complex >
assign(const idx_vector &i, const Array< Complex > &rhs)Array< Complex >inline
assign(const idx_vector &i, const idx_vector &j, const Array< Complex > &rhs, const Complex &rfv)Array< Complex >
assign(const idx_vector &i, const idx_vector &j, const Array< Complex > &rhs)Array< Complex >inline
assign(const Array< idx_vector > &ia, const Array< Complex > &rhs, const Complex &rfv)Array< Complex >
assign(const Array< idx_vector > &ia, const Array< Complex > &rhs)Array< Complex >inline
byte_size(void) constArray< Complex >inline
capacity(void) constArray< Complex >inline
cat(int dim, octave_idx_type n, const Array< Complex > *array_list)Array< Complex >static
changesign(void)MArray< Complex >
checkelem(octave_idx_type n)Array< Complex >
checkelem(octave_idx_type i, octave_idx_type j)Array< Complex >
checkelem(octave_idx_type i, octave_idx_type j, octave_idx_type k)Array< Complex >
checkelem(const Array< octave_idx_type > &ra_idx)Array< Complex >
checkelem(octave_idx_type n) constArray< Complex >
checkelem(octave_idx_type i, octave_idx_type j) constArray< Complex >
checkelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< Complex >
checkelem(const Array< octave_idx_type > &ra_idx) constArray< Complex >
chop_trailing_singletons(void) GCC_ATTR_DEPRECATEDArray< Complex >inline
clear(void)Array< Complex >
clear(const dim_vector &dv)Array< Complex >
clear(octave_idx_type r, octave_idx_type c)Array< Complex >inline
cols(void) constArray< Complex >inline
column(octave_idx_type i) const ComplexMatrix
column_is_real_only(octave_idx_type) const ComplexMatrix
column_max(void) const ComplexMatrix
column_max(Array< octave_idx_type > &index) const ComplexMatrix
column_min(void) const ComplexMatrix
column_min(Array< octave_idx_type > &index) const ComplexMatrix
column_vector_type typedefComplexMatrix
columns(void) constArray< Complex >inline
compare_fcn_type typedefArray< Complex >
ComplexMatrix(void)ComplexMatrixinline
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 ComplexMatrix &a)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 ComplexRowVector &rv)ComplexMatrixexplicit
ComplexMatrix(const ComplexColumnVector &cv)ComplexMatrixexplicit
ComplexMatrix(const ComplexDiagMatrix &a)ComplexMatrixexplicit
ComplexMatrix(const boolMatrix &a)ComplexMatrixexplicit
ComplexMatrix(const charMatrix &a)ComplexMatrixexplicit
compute_index(octave_idx_type i, octave_idx_type j) constArray< Complex >
compute_index(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< Complex >
compute_index(const Array< octave_idx_type > &ra_idx) constArray< Complex >
compute_index_unchecked(const Array< octave_idx_type > &ra_idx) constArray< Complex >inline
conj(const ComplexMatrix &a)ComplexMatrixfriend
crefT typedefArray< Complex >
cumprod(int dim=-1) const ComplexMatrix
cumsum(int dim=-1) const ComplexMatrix
data(void) constArray< Complex >inline
delete_elements(const idx_vector &i)Array< Complex >
delete_elements(int dim, const idx_vector &i)Array< Complex >
delete_elements(const Array< idx_vector > &ia)Array< Complex >
determinant(void) const ComplexMatrix
determinant(octave_idx_type &info) const ComplexMatrix
determinant(octave_idx_type &info, double &rcon, int calc_cond=1) const ComplexMatrix
determinant(MatrixType &mattype, octave_idx_type &info, double &rcon, int calc_cond=1) const ComplexMatrix
diag(octave_idx_type k=0) const ComplexMatrix
diag(octave_idx_type m, octave_idx_type n) const ComplexMatrix
dim1(void) constArray< Complex >inline
dim2(void) constArray< Complex >inline
dim3(void) constArray< Complex >inline
dimensionsArray< Complex >protected
dims(void) constArray< Complex >inline
elem(octave_idx_type n)Array< Complex >inline
elem(octave_idx_type i, octave_idx_type j)Array< Complex >inline
elem(octave_idx_type i, octave_idx_type j, octave_idx_type k)Array< Complex >inline
elem(const Array< octave_idx_type > &ra_idx)Array< Complex >inline
elem(octave_idx_type n) constArray< Complex >inline
elem(octave_idx_type i, octave_idx_type j) constArray< Complex >inline
elem(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< Complex >inline
elem(const Array< octave_idx_type > &ra_idx) constArray< Complex >inline
element_type typedefArray< Complex >
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
find(octave_idx_type n=-1, bool backward=false) constArray< Complex >
finverse(MatrixType &mattype, octave_idx_type &info, double &rcon, int force, int calc_cond) const ComplexMatrixprivate
fortran_vec(void) constArray< Complex >inline
fortran_vec(void)Array< Complex >
fourier(void) const ComplexMatrix
fourier2d(void) const ComplexMatrix
fsolve(MatrixType &typ, const ComplexMatrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, bool calc_cond=false) const ComplexMatrixprivate
hermitian(void) const ComplexMatrixinline
MArray< Complex >::hermitian(Complex(*fcn)(const Complex &)=0) constMArray< Complex >inline
idx_add(const idx_vector &idx, Complexval)MArray< Complex >
idx_add(const idx_vector &idx, const MArray< Complex > &vals)MArray< Complex >
idx_add_nd(const idx_vector &idx, const MArray< Complex > &vals, int dim=-1)MArray< Complex >
idx_max(const idx_vector &idx, const MArray< Complex > &vals)MArray< Complex >
idx_min(const idx_vector &idx, const MArray< Complex > &vals)MArray< Complex >
ifourier(void) const ComplexMatrix
ifourier2d(void) const ComplexMatrix
index(const idx_vector &i) constArray< Complex >
index(const idx_vector &i, const idx_vector &j) constArray< Complex >
index(const Array< idx_vector > &ia) constArray< Complex >
index(const idx_vector &i, bool resize_ok, const Complex &rfv) constArray< Complex >
index(const idx_vector &i, bool resize_ok) constArray< Complex >inline
index(const idx_vector &i, const idx_vector &j, bool resize_ok, const Complex &rfv) constArray< Complex >
index(const idx_vector &i, const idx_vector &j, bool resize_ok) constArray< Complex >inline
index(const Array< idx_vector > &ia, bool resize_ok, const Complex &rfv) constArray< Complex >
index(const Array< idx_vector > &ia, bool resize_ok) constArray< Complex >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
MArray< Complex >::insert(const Array< Complex > &a, const Array< octave_idx_type > &idx)Array< Complex >
MArray< Complex >::insert(const Array< Complex > &a, octave_idx_type r, octave_idx_type c)Array< Complex >
inverse(void) const ComplexMatrix
inverse(octave_idx_type &info) const ComplexMatrix
inverse(octave_idx_type &info, double &rcon, int force=0, int calc_cond=1) 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, int force=0, int calc_cond=1) const ComplexMatrix
ipermute(const Array< octave_idx_type > &vec) constMArray< Complex >inline
is_empty(void) constArray< Complex >inline
is_hermitian(void) const ComplexMatrix
is_shared(void)Array< Complex >inline
is_sorted(sortmode mode=UNSORTED) constArray< Complex >
is_sorted_rows(sortmode mode=UNSORTED) constArray< Complex >
is_square(void) constArray< Complex >inline
is_vector(void) constArray< Complex >inline
jit_array_rep(void) constArray< Complex >inline
jit_dimensions(void) constArray< Complex >inline
jit_ref_count(void)Array< Complex >inline
jit_slice_data(void) constArray< Complex >inline
length(void) constArray< Complex >inline
linear_slice(octave_idx_type lo, octave_idx_type up) constArray< Complex >
lookup(const Complex &value, sortmode mode=UNSORTED) constArray< Complex >
lookup(const Array< Complex > &values, sortmode mode=UNSORTED) constArray< Complex >
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
ltsolve(MatrixType &typ, const ComplexMatrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, bool calc_cond=false, blas_trans_type transt=blas_no_trans) const ComplexMatrixprivate
make_unique(void)Array< Complex >inline
map(F fcn) constArray< Complex >inline
map(U(&fcn)(Complex)) constArray< Complex >inline
map(U(&fcn)(const Complex &)) constArray< Complex >inline
MArray(Complex *sdata, octave_idx_type slen, octave_idx_type *adims, void *arep)MArray< Complex >inlineprotected
MArray(void)MArray< Complex >inline
MArray(octave_idx_type n) GCC_ATTR_DEPRECATEDMArray< Complex >inlineexplicit
MArray(octave_idx_type n, const Complex &val) GCC_ATTR_DEPRECATEDMArray< 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
maybe_economize(void)Array< Complex >inline
mex_get_data(void) constArray< Complex >inline
ndims(void) constArray< Complex >inline
nelem(void) constArray< Complex >inline
nnz(void) constArray< Complex >
nth_element(const idx_vector &n, int dim=0) constArray< Complex >
numel(void) constArray< Complex >inline
operator!(void) const ComplexMatrix
operator!=(const ComplexMatrix &a) const ComplexMatrix
operator()(octave_idx_type n)Array< Complex >inline
operator()(octave_idx_type i, octave_idx_type j)Array< Complex >inline
operator()(octave_idx_type i, octave_idx_type j, octave_idx_type k)Array< Complex >inline
operator()(const Array< octave_idx_type > &ra_idx)Array< Complex >inline
operator()(octave_idx_type n) constArray< Complex >inline
operator()(octave_idx_type i, octave_idx_type j) constArray< Complex >inline
operator()(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< Complex >inline
operator()(const Array< octave_idx_type > &ra_idx) constArray< Complex >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)ComplexMatrixinline
MArray< Complex >::operator=(const MArray< Complex > &a)MArray< Complex >inline
Array< Complex >::operator=(const Array< Complex > &a)Array< Complex >inline
operator==(const ComplexMatrix &a) const ComplexMatrix
operator>>(std::istream &is, ComplexMatrix &a)ComplexMatrixfriend
optimize_dimensions(const dim_vector &dv)Array< Complex >
page(octave_idx_type k) constArray< Complex >
pages(void) constArray< Complex >inline
permute(const Array< octave_idx_type > &vec, bool inv=false) constMArray< Complex >inline
print_info(std::ostream &os, const std::string &prefix) constArray< Complex >
prod(int dim=-1) const ComplexMatrix
pseudo_inverse(double tol=0.0) const ComplexMatrix
rcond(void) const ComplexMatrix
rcond(MatrixType &mattype) const ComplexMatrix
repArray< Complex >protected
reshape(const dim_vector &new_dims) constMArray< Complex >inline
Array< Complex >::reshape(octave_idx_type nr, octave_idx_type nc) constArray< Complex >inline
resize(octave_idx_type nr, octave_idx_type nc, const Complex &rfv=Complex(0))ComplexMatrixinline
MArray< Complex >::resize(octave_idx_type n) GCC_ATTR_DEPRECATEDArray< Complex >inline
MArray< Complex >::resize(octave_idx_type nr, octave_idx_type nc) GCC_ATTR_DEPRECATEDArray< Complex >inline
MArray< Complex >::resize(const dim_vector &dv, const Complex &rfv)Array< Complex >
MArray< Complex >::resize(const dim_vector &dv)Array< Complex >inline
resize1(octave_idx_type n, const Complex &rfv)Array< Complex >
resize1(octave_idx_type n)Array< Complex >inline
resize_fill_value(void) constArray< Complex >virtual
row(octave_idx_type i) const ComplexMatrix
row_is_real_only(octave_idx_type) const ComplexMatrix
row_max(void) const ComplexMatrix
row_max(Array< octave_idx_type > &index) const ComplexMatrix
row_min(void) const ComplexMatrix
row_min(Array< octave_idx_type > &index) const ComplexMatrix
row_vector_type typedefComplexMatrix
rows(void) constArray< Complex >inline
slice_dataArray< Complex >protected
slice_lenArray< Complex >protected
solve(MatrixType &typ, const Matrix &b) const ComplexMatrix
solve(MatrixType &typ, const Matrix &b, octave_idx_type &info) const ComplexMatrix
solve(MatrixType &typ, const Matrix &b, octave_idx_type &info, double &rcon) const ComplexMatrix
solve(MatrixType &typ, 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 &typ, const ComplexMatrix &b) const ComplexMatrix
solve(MatrixType &typ, const ComplexMatrix &b, octave_idx_type &info) const ComplexMatrix
solve(MatrixType &typ, const ComplexMatrix &b, octave_idx_type &info, double &rcon) const ComplexMatrix
solve(MatrixType &typ, 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 &typ, const ColumnVector &b) const ComplexMatrix
solve(MatrixType &typ, const ColumnVector &b, octave_idx_type &info) const ComplexMatrix
solve(MatrixType &typ, const ColumnVector &b, octave_idx_type &info, double &rcon) const ComplexMatrix
solve(MatrixType &typ, 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 &typ, const ComplexColumnVector &b) const ComplexMatrix
solve(MatrixType &typ, const ComplexColumnVector &b, octave_idx_type &info) const ComplexMatrix
solve(MatrixType &typ, const ComplexColumnVector &b, octave_idx_type &info, double &rcon) const ComplexMatrix
solve(MatrixType &typ, 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 typedefComplexMatrix
sort(int dim=0, sortmode mode=ASCENDING) constArray< Complex >
sort(Array< octave_idx_type > &sidx, int dim=0, sortmode mode=ASCENDING) constArray< Complex >
sort_rows_idx(sortmode mode=ASCENDING) constArray< Complex >
squeeze(void) constMArray< Complex >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) constArray< Complex >inline
test_all(F fcn) constArray< Complex >inline
test_all(bool(&fcn)(Complex)) constArray< Complex >inline
test_all(bool(&fcn)(const Complex &)) constArray< Complex >inline
test_any(F fcn) constArray< Complex >inline
test_any(bool(&fcn)(Complex)) constArray< Complex >inline
test_any(bool(&fcn)(const Complex &)) constArray< Complex >inline
tinverse(MatrixType &mattype, octave_idx_type &info, double &rcon, int force, int calc_cond) const ComplexMatrixprivate
too_large_for_float(void) const ComplexMatrix
transpose(void) const ComplexMatrixinline
utsolve(MatrixType &typ, const ComplexMatrix &b, octave_idx_type &info, double &rcon, solve_singularity_handler sing_handler, bool calc_cond=false, blas_trans_type transt=blas_no_trans) const ComplexMatrixprivate
xelem(octave_idx_type n)Array< Complex >inline
xelem(octave_idx_type n) constArray< Complex >inline
xelem(octave_idx_type i, octave_idx_type j)Array< Complex >inline
xelem(octave_idx_type i, octave_idx_type j) constArray< Complex >inline
xelem(octave_idx_type i, octave_idx_type j, octave_idx_type k)Array< Complex >inline
xelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) constArray< Complex >inline
xelem(const Array< octave_idx_type > &ra_idx)Array< Complex >inline
xelem(const Array< octave_idx_type > &ra_idx) constArray< Complex >inline
~Array(void)Array< Complex >inlinevirtual
~MArray(void)MArray< Complex >inline