This is the complete list of members for FloatMatrix, including all inherited members.
| abs() const | FloatMatrix | |
| all(int dim=-1) const | FloatNDArray | |
| all_elements_are_int_or_inf_or_nan() const | FloatNDArray | |
| all_elements_are_zero() const | FloatNDArray | |
| all_integers(float &max_val, float &min_val) const | FloatNDArray | |
| all_integers() const | FloatNDArray | |
| any(int dim=-1) const | FloatNDArray | |
| any_element_is_inf_or_nan() const | FloatNDArray | |
| any_element_is_nan() const | FloatNDArray | |
| any_element_is_negative(bool=false) const | FloatNDArray | |
| any_element_is_positive(bool=false) const | FloatNDArray | |
| any_element_not_one_or_zero() 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, 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 > | |
| 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() | FloatNDArray | 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 | FloatMatrix | |
| column_max() const | FloatMatrix | |
| column_max(Array< octave_idx_type > &index) const | FloatMatrix | |
| column_min() const | FloatMatrix | |
| column_min(Array< octave_idx_type > &index) const | FloatMatrix | |
| column_vector_type typedef | FloatMatrix | |
| columns() const | Array< T, Alloc > | inline |
| compare_fcn_type typedef | Array< T, Alloc > | |
| 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, Alloc > | |
| MArray< float >::compute_index(octave_idx_type i, octave_idx_type j, octave_idx_type k) const | Array< T, Alloc > | |
| MArray< float >::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 > | |
| 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, Alloc > | |
| 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() 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 | 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() const | Array< T, Alloc > | inline |
| dim2() const | Array< T, Alloc > | inline |
| dim3() const | Array< T, Alloc > | inline |
| dims() const | Array< T, Alloc > | inline |
| dprod(int dim=-1) const | FloatNDArray | |
| dsum(int dim=-1) const | FloatNDArray | |
| 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 | 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, 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 > | |
| FloatComplexMatrix | FloatMatrix | friend |
| FloatMatrix()=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() | 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() | Array< T, Alloc > | inline |
| fourier() const | FloatMatrix | |
| FloatNDArray::fourier(int dim=1) const | FloatNDArray | |
| fourier2d() const | FloatMatrix | |
| fourierNd() const | FloatNDArray | |
| hermitian() const | FloatMatrix | inline |
| FloatNDArray::hermitian(float(*fcn)(const float &)=nullptr) const | MArray< float > | inline |
| Array::hermitian(T(*fcn)(const T &)=nullptr) const | Array< T, Alloc > | |
| idx_add(const octave::idx_vector &idx, float val) | MArray< float > | |
| idx_add(const octave::idx_vector &idx, const MArray< float > &vals) | MArray< float > | |
| idx_add_nd(const octave::idx_vector &idx, const MArray< float > &vals, int dim=-1) | MArray< float > | |
| idx_max(const octave::idx_vector &idx, const MArray< float > &vals) | MArray< float > | |
| idx_min(const octave::idx_vector &idx, const MArray< float > &vals) | MArray< float > | |
| ifourier() const | FloatMatrix | |
| FloatNDArray::ifourier(int dim=1) const | FloatNDArray | |
| ifourier2d() const | FloatMatrix | |
| ifourierNd() const | FloatNDArray | |
| imag | FloatMatrix | friend |
| increment_index(Array< octave_idx_type > &ra_idx, const dim_vector &dimensions, int start_dimension=0) | FloatNDArray | 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 > | |
| 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, Alloc > &a, const Array< octave_idx_type > &idx) | Array< T, Alloc > | |
| MArray< float >::insert(const Array< T, Alloc > &a, octave_idx_type r, octave_idx_type c) | Array< T, Alloc > | |
| inverse() 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() 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 | FloatNDArray | |
| isinf() const | FloatNDArray | |
| isnan() const | FloatNDArray | |
| issorted(sortmode mode=UNSORTED) const | Array< T, Alloc > | |
| issorted(sortmode) const | Array< T, Alloc > | |
| issorted(sortmode) const | Array< T, Alloc > | |
| issquare() const | Array< T, Alloc > | inline |
| issymmetric() const | FloatMatrix | |
| 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 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 | |
| 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< 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() | Array< T, Alloc > | inline |
| min(int dim=-1) const | FloatNDArray | |
| min(Array< octave_idx_type > &index, int dim=-1) const | FloatNDArray | |
| 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 | FloatNDArray | |
| operator!=(const FloatMatrix &a) const | FloatMatrix | |
| 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 FloatDiagMatrix &a) | FloatMatrix | |
| operator-=(const FloatDiagMatrix &a) | FloatMatrix | |
| operator<< | 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, Alloc > &a) | Array< T, Alloc > | inline |
| Array::operator=(Array< T, Alloc > &&a) | Array< T, Alloc > | inline |
| operator==(const FloatMatrix &a) const | FloatMatrix | |
| operator>> | FloatMatrix | 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< float > | inline |
| print_info(std::ostream &os, const std::string &prefix) const | Array< T, Alloc > | |
| prod(int dim=-1) const | FloatMatrix | |
| pseudo_inverse(float tol=0.0) const | FloatMatrix | |
| rcond() const | FloatMatrix | |
| rcond(MatrixType &mattype) const | FloatMatrix | |
| real | 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 | |
| reshape(const dim_vector &new_dims) const | MArray< float > | 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, float rfv=0) | FloatMatrix | inline |
| FloatNDArray::resize(const dim_vector &dv, const T &rfv) | Array< T, Alloc > | |
| FloatNDArray::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 | FloatMatrix | |
| row_max() const | FloatMatrix | |
| row_max(Array< octave_idx_type > &index) const | FloatMatrix | |
| row_min() const | FloatMatrix | |
| row_min(Array< octave_idx_type > &index) const | FloatMatrix | |
| row_vector_type typedef | FloatMatrix | |
| rows() const | Array< T, Alloc > | inline |
| rwdata() | Array< T, Alloc > | |
| size(const size_type d) const | Array< T, Alloc > | inline |
| size_type typedef | Array< T, Alloc > | |
| 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, 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 | 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, 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 | FloatNDArray | |
| transpose() const | FloatMatrix | 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 |
| ~Array() | Array< T, Alloc > | inlinevirtual |
| ~FloatMatrix()=default | FloatMatrix | |
| ~FloatNDArray()=default | FloatNDArray | |
| ~MArray()=default | MArray< float > |