This is the complete list of members for FloatMatrix, including all inherited members.
abs(void) const | FloatMatrix | |
all(int dim=-1) const | FloatNDArray | |
all_elements_are_int_or_inf_or_nan(void) const | FloatNDArray | |
all_elements_are_zero(void) const | FloatNDArray | |
all_integers(float &max_val, float &min_val) const | FloatNDArray | |
all_integers(void) const | FloatNDArray | |
any(int dim=-1) const | FloatNDArray | |
any_element_is_inf_or_nan(void) const | FloatNDArray | |
any_element_is_nan(void) const | FloatNDArray | |
any_element_is_negative(bool=false) const | FloatNDArray | |
any_element_is_positive(bool=false) const | FloatNDArray | |
any_element_not_one_or_zero(void) const | FloatNDArray | |
append(const FloatMatrix &a) const | FloatMatrix | |
append(const FloatRowVector &a) const | FloatMatrix | |
append(const FloatColumnVector &a) const | FloatMatrix | |
append(const FloatDiagMatrix &a) const | FloatMatrix | |
Array(const Array< T > &a, const dim_vector &dv, octave_idx_type l, octave_idx_type u) | Array< T > | inlineprotected |
Array(T *sdata, octave_idx_type slen, octave_idx_type *adims, void *arep) | Array< T > | inlineprotected |
Array(void) | Array< T > | inline |
Array(const dim_vector &dv) | Array< T > | inlineexplicit |
Array(const dim_vector &dv, const T &val) | Array< T > | inlineexplicit |
Array(const Array< T > &a, const dim_vector &dv) | Array< T > | |
Array(const Container< T > &a, const dim_vector &dv) | Array< T > | |
Array(const Array< U > &a) | Array< T > | inline |
Array(const Array< T > &a) | Array< T > | inline |
Array(Array< T > &&a) | Array< T > | inline |
as_column(void) const | Array< T > | inline |
as_matrix(void) const | Array< T > | inline |
as_row(void) const | Array< T > | inline |
assign(const idx_vector &i, const Array< T > &rhs, const T &rfv) | Array< T > | |
assign(const idx_vector &i, const Array< T > &rhs) | Array< T > | inline |
assign(const idx_vector &i, const idx_vector &j, const Array< T > &rhs, const T &rfv) | Array< T > | |
assign(const idx_vector &i, const idx_vector &j, const Array< T > &rhs) | Array< T > | inline |
assign(const Array< idx_vector > &ia, const Array< T > &rhs, const T &rfv) | Array< T > | |
assign(const Array< idx_vector > &ia, const Array< T > &rhs) | Array< T > | inline |
byte_size(void) const | Array< T > | inline |
cat(int dim, octave_idx_type n, const Array< T > *array_list) | Array< T > | static |
changesign(void) | FloatNDArray | inline |
checkelem(octave_idx_type n) | Array< T > | |
checkelem(octave_idx_type i, octave_idx_type j) | Array< T > | |
checkelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T > | |
checkelem(const Array< octave_idx_type > &ra_idx) | Array< T > | |
checkelem(octave_idx_type n) const | Array< T > | |
checkelem(octave_idx_type i, octave_idx_type j) const | Array< T > | |
checkelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T > | |
checkelem(const Array< octave_idx_type > &ra_idx) const | Array< T > | |
clear(void) | Array< T > | |
clear(const dim_vector &dv) | Array< T > | |
clear(octave_idx_type r, octave_idx_type c) | Array< T > | inline |
cols(void) const | Array< T > | inline |
column(octave_idx_type i) const | FloatMatrix | |
column_max(void) const | FloatMatrix | |
column_max(Array< octave_idx_type > &index) const | FloatMatrix | |
column_min(void) const | FloatMatrix | |
column_min(Array< octave_idx_type > &index) const | FloatMatrix | |
column_vector_type typedef | FloatMatrix | |
columns(void) const | Array< T > | inline |
compare_fcn_type typedef | Array< T > | |
complex_diag_matrix_type typedef | FloatMatrix | |
complex_elt_type typedef | FloatMatrix | |
complex_matrix_type typedef | FloatMatrix | |
compute_index(Array< octave_idx_type > &ra_idx, const dim_vector &dimensions) | FloatNDArray | static |
MArray< float >::compute_index(octave_idx_type i, octave_idx_type j) const | Array< T > | |
MArray< float >::compute_index(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T > | |
MArray< float >::compute_index(const Array< octave_idx_type > &ra_idx) const | Array< T > | |
compute_index_unchecked(const Array< octave_idx_type > &ra_idx) const | Array< T > | inline |
concat(const FloatNDArray &rb, const Array< octave_idx_type > &ra_idx) | FloatNDArray | |
concat(const FloatComplexNDArray &rb, const Array< octave_idx_type > &ra_idx) | FloatNDArray | |
concat(const charNDArray &rb, const Array< octave_idx_type > &ra_idx) | FloatNDArray | |
crefT typedef | Array< T > | |
cummax(int dim=-1) const | FloatNDArray | |
cummax(Array< octave_idx_type > &index, int dim=-1) const | FloatNDArray | |
cummin(int dim=-1) const | FloatNDArray | |
cummin(Array< octave_idx_type > &index, int dim=-1) const | FloatNDArray | |
cumprod(int dim=-1) const | FloatMatrix | |
cumsum(int dim=-1) const | FloatMatrix | |
data(void) const | Array< T > | inline |
delete_elements(const idx_vector &i) | Array< T > | |
delete_elements(int dim, const idx_vector &i) | Array< T > | |
delete_elements(const Array< idx_vector > &ia) | Array< T > | |
determinant(void) const | FloatMatrix | |
determinant(octave_idx_type &info) const | FloatMatrix | |
determinant(octave_idx_type &info, float &rcon, bool calc_cond=true) const | FloatMatrix | |
determinant(MatrixType &mattype, octave_idx_type &info, float &rcon, bool calc_cond=true) const | FloatMatrix | |
diag(octave_idx_type k=0) const | FloatMatrix | |
diag(octave_idx_type m, octave_idx_type n) const | FloatMatrix | |
diff(octave_idx_type order=1, int dim=-1) const | FloatNDArray | |
dim1(void) const | Array< T > | inline |
dim2(void) const | Array< T > | inline |
dim3(void) const | Array< T > | inline |
dimensions | Array< T > | protected |
dims(void) const | Array< T > | inline |
dprod(int dim=-1) const | FloatNDArray | |
dsum(int dim=-1) const | FloatNDArray | |
elem(octave_idx_type n) | Array< T > | inline |
elem(octave_idx_type i, octave_idx_type j) | Array< T > | inline |
elem(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T > | inline |
elem(const Array< octave_idx_type > &ra_idx) | Array< T > | inline |
elem(octave_idx_type n) const | Array< T > | inline |
elem(octave_idx_type i, octave_idx_type j) const | Array< T > | inline |
elem(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T > | inline |
elem(const Array< octave_idx_type > &ra_idx) const | Array< T > | inline |
element_type typedef | Array< T > | |
extract(octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) const | FloatMatrix | |
extract_n(octave_idx_type r1, octave_idx_type c1, octave_idx_type nr, octave_idx_type nc) const | FloatMatrix | |
fill(float val) | FloatMatrix | |
fill(float val, octave_idx_type r1, octave_idx_type c1, octave_idx_type r2, octave_idx_type c2) | FloatMatrix | |
FloatNDArray::fill(const T &val) | Array< T > | |
find(octave_idx_type n=-1, bool backward=false) const | Array< T > | |
find(octave_idx_type, bool) const | Array< T > | |
finverse(MatrixType &mattype, octave_idx_type &info, float &rcon, bool force, bool calc_cond) const | FloatMatrix | private |
FloatComplexMatrix class | FloatMatrix | friend |
FloatMatrix(void)=default | FloatMatrix | |
FloatMatrix(const FloatMatrix &a)=default | FloatMatrix | |
FloatMatrix(octave_idx_type r, octave_idx_type c) | FloatMatrix | inline |
FloatMatrix(octave_idx_type r, octave_idx_type c, float val) | FloatMatrix | inline |
FloatMatrix(const dim_vector &dv) | FloatMatrix | inline |
FloatMatrix(const dim_vector &dv, float val) | FloatMatrix | inline |
FloatMatrix(const MArray< U > &a) | FloatMatrix | inline |
FloatMatrix(const Array< U > &a) | FloatMatrix | inline |
FloatMatrix(const FloatRowVector &rv) | FloatMatrix | explicit |
FloatMatrix(const FloatColumnVector &cv) | FloatMatrix | explicit |
FloatMatrix(const FloatDiagMatrix &a) | FloatMatrix | explicit |
FloatMatrix(const MDiagArray2< float > &a) | FloatMatrix | explicit |
FloatMatrix(const DiagArray2< float > &a) | FloatMatrix | explicit |
FloatMatrix(const PermMatrix &a) | FloatMatrix | explicit |
FloatMatrix(const boolMatrix &a) | FloatMatrix | explicit |
FloatMatrix(const charMatrix &a) | FloatMatrix | explicit |
FloatNDArray(void) | FloatNDArray | inline |
FloatNDArray(const dim_vector &dv) | FloatNDArray | inline |
FloatNDArray(const dim_vector &dv, float val) | FloatNDArray | inline |
FloatNDArray(const FloatNDArray &a) | FloatNDArray | inline |
FloatNDArray(const MArray< U > &a) | FloatNDArray | inline |
FloatNDArray(const Array< U > &a) | FloatNDArray | inline |
FloatNDArray(const intNDArray< U > &a) | FloatNDArray | inlineexplicit |
FloatNDArray(const charNDArray &) | FloatNDArray | |
fortran_vec(void) const | Array< T > | inline |
fortran_vec(void) | Array< T > | |
fourier(void) const | FloatMatrix | |
FloatNDArray::fourier(int dim=1) const | FloatNDArray | |
fourier2d(void) const | FloatMatrix | |
fourierNd(void) const | FloatNDArray | |
fsolve(MatrixType &mattype, const FloatMatrix &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, bool calc_cond=false) const | FloatMatrix | private |
hermitian(void) const | FloatMatrix | inline |
FloatNDArray::hermitian(float(*fcn)(const float &)=nullptr) const | MArray< float > | inline |
Array::hermitian(T(*fcn)(const T &)=nullptr) const | Array< T > | |
idx_add(const idx_vector &idx, float val) | MArray< float > | |
idx_add(const idx_vector &idx, const MArray< float > &vals) | MArray< float > | |
idx_add_nd(const idx_vector &idx, const MArray< float > &vals, int dim=-1) | MArray< float > | |
idx_max(const idx_vector &idx, const MArray< float > &vals) | MArray< float > | |
idx_min(const idx_vector &idx, const MArray< float > &vals) | MArray< float > | |
ifourier(void) const | FloatMatrix | |
FloatNDArray::ifourier(int dim=1) const | FloatNDArray | |
ifourier2d(void) const | FloatMatrix | |
ifourierNd(void) const | FloatNDArray | |
imag(const FloatComplexMatrix &a) | FloatMatrix | friend |
increment_index(Array< octave_idx_type > &ra_idx, const dim_vector &dimensions, int start_dimension=0) | FloatNDArray | static |
index(const idx_vector &i) const | Array< T > | |
index(const idx_vector &i, const idx_vector &j) const | Array< T > | |
index(const Array< idx_vector > &ia) const | Array< T > | |
index(const idx_vector &i, bool resize_ok, const T &rfv) const | Array< T > | |
index(const idx_vector &i, bool resize_ok) const | Array< T > | inline |
index(const idx_vector &i, const idx_vector &j, bool resize_ok, const T &rfv) const | Array< T > | |
index(const idx_vector &i, const idx_vector &j, bool resize_ok) const | Array< T > | inline |
index(const Array< idx_vector > &ia, bool resize_ok, const T &rfv) const | Array< T > | |
index(const Array< idx_vector > &ia, bool resize_ok) const | Array< T > | inline |
insert(const FloatMatrix &a, octave_idx_type r, octave_idx_type c) | FloatMatrix | |
insert(const FloatRowVector &a, octave_idx_type r, octave_idx_type c) | FloatMatrix | |
insert(const FloatColumnVector &a, octave_idx_type r, octave_idx_type c) | FloatMatrix | |
insert(const FloatDiagMatrix &a, octave_idx_type r, octave_idx_type c) | FloatMatrix | |
FloatNDArray::insert(const FloatNDArray &a, octave_idx_type r, octave_idx_type c) | FloatNDArray | |
FloatNDArray::insert(const FloatNDArray &a, const Array< octave_idx_type > &ra_idx) | FloatNDArray | |
MArray< float >::insert(const Array< T > &a, const Array< octave_idx_type > &idx) | Array< T > | |
MArray< float >::insert(const Array< T > &a, octave_idx_type r, octave_idx_type c) | Array< T > | |
instantiation_guard() | Array< T > | privatestatic |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
instantiation_guard() | Array< T > | private |
inverse(void) const | FloatMatrix | |
inverse(octave_idx_type &info) const | FloatMatrix | |
inverse(octave_idx_type &info, float &rcon, bool force=false, bool calc_cond=true) const | FloatMatrix | |
inverse(MatrixType &mattype) const | FloatMatrix | |
inverse(MatrixType &mattype, octave_idx_type &info) const | FloatMatrix | |
inverse(MatrixType &mattype, octave_idx_type &info, float &rcon, bool force=false, bool calc_cond=true) const | FloatMatrix | |
ipermute(const Array< octave_idx_type > &vec) const | MArray< float > | inline |
is_nd_vector(void) const | Array< T > | inline |
is_shared(void) | Array< T > | inline |
is_sorted_rows(sortmode mode=UNSORTED) const | Array< T > | |
is_sorted_rows(sortmode) const | Array< T > | |
isempty(void) const | Array< T > | inline |
isfinite(void) const | FloatNDArray | |
isinf(void) const | FloatNDArray | |
isnan(void) const | FloatNDArray | |
issorted(sortmode mode=UNSORTED) const | Array< T > | |
issorted(sortmode mode) const | Array< T > | |
issorted(sortmode) const | Array< T > | |
issquare(void) const | Array< T > | inline |
issymmetric(void) const | FloatMatrix | |
isvector(void) const | Array< T > | inline |
jit_array_rep(void) const | Array< T > | inline |
jit_dimensions(void) const | Array< T > | inline |
jit_ref_count(void) | Array< T > | inline |
jit_slice_data(void) const | Array< T > | inline |
linear_slice(octave_idx_type lo, octave_idx_type up) const | Array< T > | |
lookup(const T &value, sortmode mode=UNSORTED) const | Array< T > | |
lookup(const Array< T > &values, sortmode mode=UNSORTED) const | Array< T > | |
lookup(idx_vector const &, sortmode) const | Array< T > | |
lookup(const Array< idx_vector > &, sortmode) const | Array< T > | |
lssolve(const FloatMatrix &b) const | FloatMatrix | |
lssolve(const FloatMatrix &b, octave_idx_type &info) const | FloatMatrix | |
lssolve(const FloatMatrix &b, octave_idx_type &info, octave_idx_type &rank) const | FloatMatrix | |
lssolve(const FloatMatrix &b, octave_idx_type &info, octave_idx_type &rank, float &rcon) const | FloatMatrix | |
lssolve(const FloatComplexMatrix &b) const | FloatMatrix | |
lssolve(const FloatComplexMatrix &b, octave_idx_type &info) const | FloatMatrix | |
lssolve(const FloatComplexMatrix &b, octave_idx_type &info, octave_idx_type &rank) const | FloatMatrix | |
lssolve(const FloatComplexMatrix &b, octave_idx_type &info, octave_idx_type &rank, float &rcon) const | FloatMatrix | |
lssolve(const FloatColumnVector &b) const | FloatMatrix | |
lssolve(const FloatColumnVector &b, octave_idx_type &info) const | FloatMatrix | |
lssolve(const FloatColumnVector &b, octave_idx_type &info, octave_idx_type &rank) const | FloatMatrix | |
lssolve(const FloatColumnVector &b, octave_idx_type &info, octave_idx_type &rank, float &rcon) const | FloatMatrix | |
lssolve(const FloatComplexColumnVector &b) const | FloatMatrix | |
lssolve(const FloatComplexColumnVector &b, octave_idx_type &info) const | FloatMatrix | |
lssolve(const FloatComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank) const | FloatMatrix | |
lssolve(const FloatComplexColumnVector &b, octave_idx_type &info, octave_idx_type &rank, float &rcon) const | FloatMatrix | |
ltsolve(MatrixType &mattype, const FloatMatrix &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, bool calc_cond=false, blas_trans_type transt=blas_no_trans) const | FloatMatrix | private |
make_unique(void) | Array< T > | inline |
map(F fcn) const | Array< T > | inline |
map(U(&fcn)(T)) const | Array< T > | inline |
map(U(&fcn)(const T &)) const | Array< T > | inline |
MArray(float *sdata, octave_idx_type slen, octave_idx_type *adims, void *arep) | MArray< float > | inlineprotected |
MArray(void) | MArray< float > | inline |
MArray(const dim_vector &dv) | MArray< float > | inlineexplicit |
MArray(const dim_vector &dv, const float &val) | MArray< float > | inlineexplicit |
MArray(const MArray< float > &a) | MArray< float > | inline |
MArray(const Array< U > &a) | MArray< float > | inline |
max(int dim=-1) const | FloatNDArray | |
max(Array< octave_idx_type > &index, int dim=-1) const | FloatNDArray | |
maybe_economize(void) | Array< T > | inline |
mex_get_data(void) const | Array< T > | inline |
min(int dim=-1) const | FloatNDArray | |
min(Array< octave_idx_type > &index, int dim=-1) const | FloatNDArray | |
ndims(void) const | Array< T > | inline |
nil_rep(void) | Array< T > | privatestatic |
nnz(void) const | Array< T > | |
nnz(void) const | Array< T > | |
nth_element(const idx_vector &n, int dim=0) const | Array< T > | |
nth_element(const idx_vector &, int) const | Array< T > | |
numel(void) const | Array< T > | inline |
operator!(void) const | FloatNDArray | |
operator!=(const FloatMatrix &a) const | FloatMatrix | |
operator()(octave_idx_type n) | Array< T > | inline |
operator()(octave_idx_type i, octave_idx_type j) | Array< T > | inline |
operator()(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T > | inline |
operator()(const Array< octave_idx_type > &ra_idx) | Array< T > | inline |
operator()(octave_idx_type n) const | Array< T > | inline |
operator()(octave_idx_type i, octave_idx_type j) const | Array< T > | inline |
operator()(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T > | inline |
operator()(const Array< octave_idx_type > &ra_idx) const | Array< T > | inline |
operator+=(const FloatDiagMatrix &a) | FloatMatrix | |
operator-=(const FloatDiagMatrix &a) | FloatMatrix | |
operator<<(std::ostream &os, const FloatMatrix &a) | FloatMatrix | friend |
operator=(const FloatMatrix &a)=default | FloatMatrix | |
FloatNDArray::operator=(const FloatNDArray &a) | FloatNDArray | inline |
MArray< float >::operator=(const MArray< float > &a) | MArray< float > | inline |
Array::operator=(const Array< T > &a) | Array< T > | inline |
Array::operator=(Array< T > &&a) | Array< T > | inline |
operator==(const FloatMatrix &a) const | FloatMatrix | |
operator>>(std::istream &is, FloatMatrix &a) | FloatMatrix | friend |
optimize_dimensions(const dim_vector &dv) | Array< T > | |
page(octave_idx_type k) const | Array< T > | |
pages(void) const | Array< T > | inline |
permute(const Array< octave_idx_type > &vec, bool inv=false) const | MArray< float > | inline |
print_info(std::ostream &os, const std::string &prefix) const | Array< T > | |
prod(int dim=-1) const | FloatMatrix | |
pseudo_inverse(float tol=0.0) const | FloatMatrix | |
rcond(void) const | FloatMatrix | |
rcond(MatrixType &mattype) const | FloatMatrix | |
real(const FloatComplexMatrix &a) | FloatMatrix | friend |
real_column_vector_type typedef | FloatMatrix | |
real_diag_matrix_type typedef | FloatMatrix | |
real_elt_type typedef | FloatMatrix | |
real_matrix_type typedef | FloatMatrix | |
real_row_vector_type typedef | FloatMatrix | |
rep | Array< T > | protected |
reshape(const dim_vector &new_dims) const | MArray< float > | inline |
Array::reshape(octave_idx_type nr, octave_idx_type nc) const | Array< T > | inline |
resize(octave_idx_type nr, octave_idx_type nc, float rfv=0) | FloatMatrix | inline |
FloatNDArray::resize(const dim_vector &dv, const T &rfv) | Array< T > | |
FloatNDArray::resize(const dim_vector &dv) | Array< T > | inline |
resize1(octave_idx_type n, const T &rfv) | Array< T > | |
resize1(octave_idx_type n) | Array< T > | inline |
resize2(octave_idx_type nr, octave_idx_type nc, const T &rfv) | Array< T > | |
resize2(octave_idx_type nr, octave_idx_type nc) | Array< T > | inline |
resize_fill_value(void) const | Array< T > | virtual |
row(octave_idx_type i) const | FloatMatrix | |
row_max(void) const | FloatMatrix | |
row_max(Array< octave_idx_type > &index) const | FloatMatrix | |
row_min(void) const | FloatMatrix | |
row_min(Array< octave_idx_type > &index) const | FloatMatrix | |
row_vector_type typedef | FloatMatrix | |
rows(void) const | Array< T > | inline |
size(const size_type d) const | Array< T > | inline |
size_type typedef | Array< T > | |
slice_data | Array< T > | protected |
slice_len | Array< T > | protected |
solve(MatrixType &mattype, const FloatMatrix &b) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatMatrix &b, octave_idx_type &info) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatMatrix &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatMatrix &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, bool singular_fallback=true, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexMatrix &b) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexMatrix &b, octave_idx_type &info) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexMatrix &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexMatrix &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, bool singular_fallback=true, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatColumnVector &b) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatColumnVector &b, octave_idx_type &info) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatColumnVector &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatColumnVector &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexColumnVector &b) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexColumnVector &b, octave_idx_type &info) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexColumnVector &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(MatrixType &mattype, const FloatComplexColumnVector &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve(const FloatMatrix &b) const | FloatMatrix | |
solve(const FloatMatrix &b, octave_idx_type &info) const | FloatMatrix | |
solve(const FloatMatrix &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(const FloatMatrix &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve(const FloatComplexMatrix &b) const | FloatMatrix | |
solve(const FloatComplexMatrix &b, octave_idx_type &info) const | FloatMatrix | |
solve(const FloatComplexMatrix &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(const FloatComplexMatrix &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve(const FloatColumnVector &b) const | FloatMatrix | |
solve(const FloatColumnVector &b, octave_idx_type &info) const | FloatMatrix | |
solve(const FloatColumnVector &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(const FloatColumnVector &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve(const FloatComplexColumnVector &b) const | FloatMatrix | |
solve(const FloatComplexColumnVector &b, octave_idx_type &info) const | FloatMatrix | |
solve(const FloatComplexColumnVector &b, octave_idx_type &info, float &rcon) const | FloatMatrix | |
solve(const FloatComplexColumnVector &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, blas_trans_type transt=blas_no_trans) const | FloatMatrix | |
solve_singularity_handler typedef | FloatMatrix | |
sort(int dim=0, sortmode mode=ASCENDING) const | Array< T > | |
sort(Array< octave_idx_type > &sidx, int dim=0, sortmode mode=ASCENDING) const | Array< T > | |
sort(int, sortmode) const | Array< T > | |
sort(Array< octave_idx_type > &sidx, int, sortmode) const | Array< T > | |
sort_rows_idx(sortmode mode=ASCENDING) const | Array< T > | |
sort_rows_idx(sortmode) const | Array< T > | |
squeeze(void) const | FloatNDArray | inline |
stack(const FloatMatrix &a) const | FloatMatrix | |
stack(const FloatRowVector &a) const | FloatMatrix | |
stack(const FloatColumnVector &a) const | FloatMatrix | |
stack(const FloatDiagMatrix &a) const | FloatMatrix | |
sum(int dim=-1) const | FloatMatrix | |
sumsq(int dim=-1) const | FloatMatrix | |
test(F fcn) const | Array< T > | inline |
test_all(F fcn) const | Array< T > | inline |
test_all(bool(&fcn)(T)) const | Array< T > | inline |
test_all(bool(&fcn)(const T &)) const | Array< T > | inline |
test_any(F fcn) const | Array< T > | inline |
test_any(bool(&fcn)(T)) const | Array< T > | inline |
test_any(bool(&fcn)(const T &)) const | Array< T > | inline |
tinverse(MatrixType &mattype, octave_idx_type &info, float &rcon, bool force, bool calc_cond) const | FloatMatrix | private |
too_large_for_float(void) const | FloatNDArray | |
transpose(void) const | FloatMatrix | inline |
utsolve(MatrixType &mattype, const FloatMatrix &b, octave_idx_type &info, float &rcon, solve_singularity_handler sing_handler, bool calc_cond=false, blas_trans_type transt=blas_no_trans) const | FloatMatrix | private |
value_type typedef | Array< T > | |
xelem(octave_idx_type n) | Array< T > | inline |
xelem(octave_idx_type n) const | Array< T > | inline |
xelem(octave_idx_type i, octave_idx_type j) | Array< T > | inline |
xelem(octave_idx_type i, octave_idx_type j) const | Array< T > | inline |
xelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) | Array< T > | inline |
xelem(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T > | inline |
xelem(const Array< octave_idx_type > &ra_idx) | Array< T > | inline |
xelem(const Array< octave_idx_type > &ra_idx) const | Array< T > | inline |
~Array(void) | Array< T > | inlinevirtual |
~FloatMatrix(void)=default | FloatMatrix | |
~MArray(void)=default | MArray< float > |