Vector representing the dimensions (size) of an Array. More...
#include "dim-vector.h"
Public Member Functions | |
dim_vector (const dim_vector &dv) | |
template<typename... Ints> | |
dim_vector (const octave_idx_type r, const octave_idx_type c, Ints... lengths) | |
Construct dim_vector for a N dimensional array. More... | |
dim_vector (dim_vector &&dv) | |
dim_vector (octave_idx_type *r) | |
dim_vector (void) | |
~dim_vector (void) | |
bool | all_ones (void) const |
bool | all_zero (void) const |
bool | any_neg (void) const |
bool | any_zero (void) const |
Array< octave_idx_type > | as_array (void) const |
dim_vector | as_column (void) const |
dim_vector | as_row (void) const |
void | chop_all_singletons (void) |
void | chop_trailing_singletons (void) |
octave_idx_type | compute_index (const octave_idx_type *idx) const |
Linear index from an index tuple. More... | |
octave_idx_type | compute_index (const octave_idx_type *idx, int nidx) const |
Linear index from an incomplete index tuple (nidx < length ()). More... | |
bool | concat (const dim_vector &dvb, int dim) |
This corresponds to cat(). More... | |
octave_idx_type | cum_compute_index (const octave_idx_type *idx) const |
Compute a linear index from an index tuple. More... | |
dim_vector | cumulative (void) const |
Return cumulative dimensions. More... | |
octave_idx_type & | elem (int i) |
octave_idx_type | elem (int i) const |
bool | empty_2d (void) const |
int | first_non_singleton (int def=0) const |
bool | hvcat (const dim_vector &dvb, int dim) |
This corresponds to [,] (horzcat, dim = 0) and [;] (vertcat, dim = 1). More... | |
int | increment_index (octave_idx_type *idx, int start=0) const |
Increment a multi-dimensional index tuple, optionally starting from an offset position and return the index of the last index position that was changed, or length () if just cycled over. More... | |
bool | is_nd_vector (void) const |
bool | isvector (void) const |
int | length (void) const |
Number of dimensions. More... | |
dim_vector | make_nd_vector (octave_idx_type n) const |
octave_idx_type | ndims (void) const |
Number of dimensions. More... | |
int | num_ones (void) const |
octave_idx_type | numel (int n=0) const |
Number of elements that a matrix with this dimensions would have. More... | |
octave_idx_type & | operator() (int i) |
octave_idx_type | operator() (int i) const |
dim_vector & | operator= (const dim_vector &dv) |
dim_vector & | operator= (dim_vector &&dv) |
dim_vector | redim (int n) const |
Force certain dimensionality, preserving numel (). More... | |
void | resize (int n, int fill_value=0) |
octave_idx_type | safe_numel (void) const |
The following function will throw a std::bad_alloc () exception if the requested size is larger than can be indexed by octave_idx_type. More... | |
dim_vector | squeeze (void) const |
std::string | str (char sep='x') const |
octave_idx_type * | to_jit (void) const |
octave_idx_type & | xelem (int i) |
octave_idx_type | xelem (int i) const |
bool | zero_by_zero (void) const |
Static Public Member Functions | |
static dim_vector | alloc (int n) |
static octave_idx_type | dim_max (void) |
Private Member Functions | |
octave_idx_type * | clonerep (void) |
Clone this->rep. More... | |
octave_idx_type & | count (void) const |
octave_idx_type | decrement_count (void) |
void | freerep (void) |
Free the rep. More... | |
octave_idx_type | increment_count (void) |
void | make_unique (void) |
octave_idx_type * | resizerep (int n, octave_idx_type fill_value) |
Clone and resize this->rep to length n, filling by given value. More... | |
Static Private Member Functions | |
static octave_idx_type * | newrep (int ndims) |
Construct a new rep with count = 1 and ndims given. More... | |
static octave_idx_type * | nil_rep (void) |
Private Attributes | |
octave_idx_type * | rep |
Friends | |
bool | operator== (const dim_vector &a, const dim_vector &b) |
Vector representing the dimensions (size) of an Array.
A dim_vector is used to represent dimensions of an Array. It is used on its constructor to specify its size, or when reshaping it.
The main thing to understand about this class, is that methods such as ndims() and numel(), return the value for an Array of these dimensions, not the actual number of elements in the dim_vector.
This implementation is more tricky than Array, but the big plus is that dim_vector requires only one allocation instead of two. It is (slightly) patterned after GCC's basic_string implementation. rep is a pointer to an array of memory, comprising count, length, and the data:
//! <count> //! <ndims> //! rep --> <dims[0]> //! <dims[1]> //! ... //!
The inlines count(), ndims() recover this data from the rep. Note that rep points to the beginning of dims to grant faster access (reinterpret_cast is assumed to be an inexpensive operation).
Definition at line 92 of file dim-vector.h.
|
inline |
Construct dim_vector for a N dimensional array.
Each argument to constructor defines the length of an additional dimension. A dim_vector always represents a minimum of 2 dimensions (just like an Array has at least 2 dimensions) and there is no upper limit on the number of dimensions.
The constructed dim_vector dv
will have two elements, , one for each dimension. It can then be used to construct a Matrix with such dimensions, i.e., 7 rows and 5 columns.
This will construct a 3 dimensional NDArray of lengths 7, 5, and 10, on the first, second, and third dimension (rows, columns, and pages) respectively.
Note that that there is no constructor that accepts only one dimension length to avoid confusion. The source for such confusion is that constructor could mean:
Using r, c, and lengths... as arguments, allow us to check at compile time that there's at least 2 dimensions specified, while maintaining type safety.
Definition at line 216 of file dim-vector.h.
References r, and Array< T >::rep.
|
inlineexplicit |
Definition at line 270 of file dim-vector.h.
Referenced by hvcat().
|
inline |
Definition at line 273 of file dim-vector.h.
|
inline |
Definition at line 276 of file dim-vector.h.
|
inlineexplicit |
Definition at line 279 of file dim-vector.h.
|
inline |
Definition at line 318 of file dim-vector.h.
References Array< T >::rep.
|
inline |
Definition at line 390 of file dim-vector.h.
References Array< T >::ndims(), and num_ones().
Referenced by octave_value_list::all_scalars(), octave_base_diag< DMT, MT >::print_as_scalar(), octave_base_matrix< MT >::print_as_scalar(), octave_base_sparse< T >::print_as_scalar(), and octave_perm_matrix::print_as_scalar().
|
inline |
Definition at line 366 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::rep.
Referenced by octave_map::concat(), do_fft2(), do_fftn(), octave::rand::do_float_nd_array(), octave::rand::do_nd_array(), Ffind(), oct_catop_matrix_struct(), and oct_catop_struct_matrix().
|
inlinestatic |
Definition at line 281 of file dim-vector.h.
References n.
Referenced by Array< T >::assign(), convolve(), do_mat2cell(), do_mat2cell_nd(), Fbase64_decode(), Freshape(), Fvec(), get_blkmm_dims(), get_red_dims(), Array< T >::index(), Array< T >::permute(), redim(), octave::workspace_model::update_table(), and zero_dims_inquire().
|
inline |
Definition at line 423 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::rep.
Referenced by Array< T >::resize().
|
inline |
Definition at line 382 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::rep.
Referenced by octave::tm_const::array_concat(), do_fft(), Farrayfun(), Fcellfun(), octave::tm_const::init(), octave::tm_const::map_concat(), octave_base_diag< DMT, MT >::print_as_scalar(), octave_base_matrix< MT >::print_as_scalar(), octave_base_sparse< T >::print_as_scalar(), octave_perm_matrix::print_as_scalar(), print_empty_nd_array(), and octave::tm_const::sparse_array_concat().
Array< octave_idx_type > dim_vector::as_array | ( | void | ) | const |
Definition at line 285 of file dim-vector.cc.
References elem(), ndims(), and retval.
Referenced by octave_base_value::dump().
|
inline |
Definition at line 445 of file dim-vector.h.
References Array< T >::ndims(), numel(), and Array< T >::xelem().
Referenced by Ffind().
|
inline |
Definition at line 453 of file dim-vector.h.
References Array< T >::ndims(), numel(), and Array< T >::xelem().
Referenced by squeeze().
void dim_vector::chop_all_singletons | ( | void | ) |
Definition at line 65 of file dim-vector.cc.
References make_unique(), ndims(), and rep.
Referenced by Array< T >::assign(), squeeze(), and zero_dims_inquire().
|
inline |
Definition at line 241 of file dim-vector.h.
References Array< T >::make_unique(), Array< T >::ndims(), and Array< T >::rep.
Referenced by Array< T >::Array(), Array< T >::assign(), Array< T >::clear(), concat(), do_rand(), Fcell(), fill_matrix(), and octave_map::reshape().
|
inlineprivate |
Clone this->rep.
Definition at line 126 of file dim-vector.h.
References Array< T >::ndims(), r, and Array< T >::rep.
|
inline |
Linear index from an index tuple.
Definition at line 522 of file dim-vector.h.
References compute_index(), and Array< T >::ndims().
Referenced by compute_index(), Array< T >::compute_index_unchecked(), do_bsxfun_op(), and do_inplace_bsxfun_op().
|
inline |
Linear index from an incomplete index tuple (nidx < length ()).
Definition at line 526 of file dim-vector.h.
References Array< T >::rep.
bool dim_vector::concat | ( | const dim_vector & | dvb, |
int | dim | ||
) |
This corresponds to cat().
Definition at line 157 of file dim-vector.cc.
References chop_trailing_singletons(), make_unique(), ndims(), rep, and resize().
Referenced by Array< T >::cat(), octave_map::cat(), Sparse< T >::cat(), do_cat(), and hvcat().
|
inlineprivate |
Definition at line 100 of file dim-vector.h.
References Array< T >::rep.
|
inline |
Compute a linear index from an index tuple.
Dimensions are required to be cumulative.
Definition at line 569 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::rep.
Referenced by do_bsxfun_op(), and do_inplace_bsxfun_op().
|
inline |
Return cumulative dimensions.
Definition at line 554 of file dim-vector.h.
References Array< T >::ndims(), Array< T >::rep, and retval.
Referenced by convolve(), do_bsxfun_op(), and do_inplace_bsxfun_op().
|
inlineprivate |
Definition at line 107 of file dim-vector.h.
References octave_atomic_decrement().
|
static |
Definition at line 59 of file dim-vector.cc.
References max().
Referenced by Fsizemax(), and safe_numel().
|
inline |
Definition at line 233 of file dim-vector.h.
References Array< T >::make_unique(), and Array< T >::xelem().
Referenced by as_array(), and squeeze().
|
inline |
Definition at line 239 of file dim-vector.h.
References Array< T >::xelem().
|
inline |
Definition at line 372 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::xelem().
|
inline |
Definition at line 510 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::xelem().
Referenced by do_accumdim_sum(), do_cellslices_nda(), do_diff(), do_fft(), Fcellslices(), Fdot(), Ffilter(), filter(), Fnth_element(), Fsort(), MArray< T >::idx_add_nd(), SparseComplexMatrix::max(), SparseMatrix::max(), SparseComplexMatrix::min(), and SparseMatrix::min().
|
inlineprivate |
bool dim_vector::hvcat | ( | const dim_vector & | dvb, |
int | dim | ||
) |
This corresponds to [,] (horzcat, dim = 0) and [;] (vertcat, dim = 1).
Definition at line 220 of file dim-vector.cc.
References dim_vector(), concat(), ndims(), and rep.
Referenced by Array< T >::cat(), Sparse< T >::cat(), octave::tm_row_const::cellify(), do_cat(), octave::tm_row_const::init(), and octave::tm_const::init().
|
inlineprivate |
Definition at line 102 of file dim-vector.h.
References octave_atomic_increment().
|
inline |
Increment a multi-dimensional index tuple, optionally starting from an offset position and return the index of the last index position that was changed, or length () if just cycled over.
Definition at line 539 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::rep.
Referenced by do_bsxfun_op(), do_inplace_bsxfun_op(), do_mat2cell(), and do_mat2cell_nd().
|
inline |
Definition at line 466 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::xelem().
Referenced by Array< T >::is_nd_vector().
|
inline |
Definition at line 461 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::xelem().
Referenced by Fdot(), Ffind(), Fissorted(), octave::get_dimensions(), Range::index(), Array< T >::isvector(), and idx_vector::isvector().
|
inline |
Number of dimensions.
Synonymous with ndims().
While this method is not officially deprecated, consider using ndims() instead to avoid confusion. Array does not have length because of its odd definition as length of the longest dimension.
Definition at line 343 of file dim-vector.h.
References Array< T >::ndims().
|
inline |
Definition at line 487 of file dim-vector.h.
References Array< T >::is_nd_vector(), n, and ndims().
Referenced by idx_vector::idx_mask_rep::idx_mask_rep(), and idx_vector::idx_vector_rep::idx_vector_rep().
|
inlineprivate |
Definition at line 165 of file dim-vector.h.
References Array< T >::rep.
Referenced by chop_all_singletons(), and concat().
|
inline |
Number of dimensions.
Returns the number of dimensions of the dim_vector. This is number of elements in the dim_vector including trailing singletons. It is also the number of dimensions an Array with this dim_vector would have.
Definition at line 334 of file dim-vector.h.
References Array< T >::rep.
Referenced by rec_resize_helper::rec_resize_helper(), Sparse< T >::Sparse(), all_colon_equiv(), as_array(), Array< T >::as_column(), Array< T >::as_matrix(), Array< T >::as_row(), Array< T >::assign(), Array< T >::cat(), octave::check_dimensions(), chop_all_singletons(), octave_uint64_matrix::complex_matrix_value(), compute_array_dimensions(), concat(), convert_cdata(), octave::convert_packcomplex_Nd(), octave::opengl_texture::create(), Array< T >::diag(), do_accumdim_sum(), do_cat(), do_cellslices_nda(), do_diff(), do_fft(), do_fft2(), do_fftn(), do_num2cell_helper(), do_trilu(), octave::opengl_renderer::draw_image(), octave::end_value(), Fbsxfun(), Fcellslices(), Fellipj(), Ffilter(), fill_matrix(), filter(), Flinspace(), octave_uint64_matrix::float_complex_matrix_value(), octave_uint64_matrix::float_matrix_value(), ComplexNDArray::fourier(), NDArray::fourier(), FloatComplexNDArray::fourier(), FloatNDArray::fourier(), ComplexNDArray::fourier2d(), NDArray::fourier2d(), FloatComplexNDArray::fourier2d(), FloatNDArray::fourier2d(), ComplexNDArray::fourierNd(), NDArray::fourierNd(), FloatComplexNDArray::fourierNd(), FloatNDArray::fourierNd(), freeze(), Fsize(), Fstruct2cell(), octave::tm_const::generic_concat(), get_blkmm_dims(), get_ra_idx(), get_red_dims(), get_vec_dims(), hvcat(), ComplexNDArray::ifourier(), NDArray::ifourier(), FloatComplexNDArray::ifourier(), FloatNDArray::ifourier(), ComplexNDArray::ifourier2d(), NDArray::ifourier2d(), FloatComplexNDArray::ifourier2d(), FloatNDArray::ifourier2d(), ComplexNDArray::ifourierNd(), NDArray::ifourierNd(), FloatComplexNDArray::ifourierNd(), FloatNDArray::ifourierNd(), increment_index(), ind2sub(), index_in_bounds(), octave::tm_const::init(), ComplexNDArray::insert(), FloatComplexNDArray::insert(), is_scalar(), is_valid_bsxfun(), is_valid_inplace_bsxfun(), isvector(), make_nd_vector(), QtHandles::Utils::makeImageFromCData(), mat2cell_mismatch(), octave_uint64_matrix::matrix_value(), SparseComplexMatrix::max(), SparseMatrix::max(), maybe_update_column(), SparseComplexMatrix::min(), SparseMatrix::min(), octave_base_value::ndims(), Array< T >::ndims(), Sparse< T >::ndims(), num_ones(), operator<<(), Array< T >::permute(), redim(), Sparse< T >::reshape(), Sparse< T >::resize(), octave_base_diag< DMT, MT >::resize(), Array< T >::resize(), safe_numel(), octave_base_int_matrix< T >::save_ascii(), octave_bool_matrix::save_ascii(), octave_cell::save_ascii(), octave_complex_matrix::save_ascii(), octave_float_complex_matrix::save_ascii(), octave_float_matrix::save_ascii(), octave_matrix::save_ascii(), octave_char_matrix_str::save_ascii(), octave_struct::save_ascii(), octave_scalar_struct::save_ascii(), octave_bool_matrix::save_binary(), octave_sparse_bool_matrix::save_binary(), octave_cell::save_binary(), octave_complex_matrix::save_binary(), octave_sparse_complex_matrix::save_binary(), octave_float_complex_matrix::save_binary(), octave_float_matrix::save_binary(), octave_matrix::save_binary(), octave_sparse_matrix::save_binary(), octave_char_matrix_str::save_binary(), octave_struct::save_binary(), octave_base_int_matrix< T >::save_binary(), octave_bool_matrix::save_hdf5(), octave_cell::save_hdf5(), octave_complex_matrix::save_hdf5(), octave_float_complex_matrix::save_hdf5(), octave_float_matrix::save_hdf5(), octave_matrix::save_hdf5(), octave_char_matrix_str::save_hdf5(), octave_base_int_matrix< T >::save_hdf5_internal(), scalar(), octave_base_value::size(), octave_class::size(), Array< T >::sort(), octave_lazy_index::sort(), squeeze(), str(), streameuler3d_internal(), try_cellfun_internal_ops(), update_index(), octave::workspace_model::update_table(), array_property::validate(), vector_equivalent(), and zero_dims_inquire().
|
inlinestaticprivate |
Construct a new rep with count = 1 and ndims given.
Definition at line 114 of file dim-vector.h.
References Array< T >::ndims(), and r.
|
staticprivate |
Definition at line 40 of file dim-vector.cc.
int dim_vector::num_ones | ( | void | ) | const |
Definition at line 103 of file dim-vector.cc.
|
inline |
Number of elements that a matrix with this dimensions would have.
Return the number of elements that a matrix with this dimension vector would have, NOT the number of dimensions (elements in the dimension vector).
Definition at line 401 of file dim-vector.h.
References elem, n, Array< T >::ndims(), and retval.
Referenced by octave::math::airy(), octave::math::biry(), compute_index(), octave::convert_packcomplex_Nd(), octave_float_matrix::convert_to_str_internal(), octave_matrix::convert_to_str_internal(), octave_sparse_matrix::convert_to_str_internal(), octave::dims_to_numel(), octave::math::do_bessel(), do_bessel(), do_bsxfun_op(), do_inplace_bsxfun_op(), do_num2cell(), do_object2cell(), Fbsxfun(), octave::fftw::fftNd(), filter(), Fregexprep(), Freshape(), get_ra_idx(), octave::fftw::ifftNd(), ind2sub(), octave_base_matrix< MT >::is_true(), octave_base_sparse< T >::is_true(), octave_perm_matrix::is_true(), octave_cell::load_ascii(), octave_char_matrix_str::load_ascii(), octave_bool_matrix::load_binary(), octave_cell::load_binary(), octave_complex_matrix::load_binary(), octave_float_complex_matrix::load_binary(), octave_float_matrix::load_binary(), octave_matrix::load_binary(), octave_char_matrix_str::load_binary(), octave_base_int_matrix< T >::load_binary(), octave_bool_matrix::load_hdf5(), octave_cell::load_hdf5(), octave_base_value::numel(), octave_class::numel(), octave_print_internal_template(), read_mat5_binary_element(), Sparse< T >::reshape(), octave_bool::resize(), octave_complex::resize(), octave_float_scalar::resize(), octave_float_complex::resize(), octave_uint64_scalar::resize(), octave_scalar::resize(), octave_cell::save_ascii(), octave_char_matrix_str::save_ascii(), octave_cell::save_binary(), octave_complex_matrix::save_binary(), octave_float_complex_matrix::save_binary(), octave_float_matrix::save_binary(), octave_matrix::save_binary(), octave_char_matrix_str::save_binary(), octave_cell::save_hdf5(), octave_char_matrix_str::save_hdf5(), save_mat5_binary_element(), Array< T >::sort(), octave_cell::subsasgn(), and octave_struct::subsasgn().
|
inline |
Definition at line 345 of file dim-vector.h.
References elem.
|
inline |
Definition at line 347 of file dim-vector.h.
References elem.
|
inline |
Definition at line 286 of file dim-vector.h.
References Array< T >::rep, and rep.
|
inline |
Definition at line 300 of file dim-vector.h.
References Array< T >::rep.
dim_vector dim_vector::redim | ( | int | n | ) | const |
Force certain dimensionality, preserving numel ().
Missing dimensions are set to 1, redundant are folded into the trailing one. If n = 1, the result is 2d and the second dim is 1 (dim_vectors are always at least 2D).
Definition at line 245 of file dim-vector.cc.
References alloc(), n, ndims(), Array< T >::rep, rep, and retval.
Referenced by Array< T >::as_matrix(), Array< T >::assign(), octave_base_matrix< MT >::assign(), compute_index(), convolve(), octave::dims_to_numel(), do_bsxfun_op(), do_inplace_bsxfun_op(), Fcell2struct(), Fdot(), Find2sub(), Fsize(), MArray< T >::idx_add_nd(), Sparse< T >::index(), Array< T >::index(), Array< T >::insert(), Array< T >::resize(), sub2ind(), octave_cell::subsasgn(), octave_struct::subsasgn(), and octave::tree_evaluator::visit_simple_for_command().
|
inline |
Definition at line 349 of file dim-vector.h.
References len, n, Array< T >::ndims(), r, and Array< T >::rep.
Referenced by octave_map::cat(), compute_array_dimensions(), concat(), convert_cdata(), mxArray_matlab::dims_to_dim_vector(), do_accumdim_sum(), do_bsxfun_op(), octave_map::do_cat(), do_num2cell_helper(), do_rand(), octave::end_value(), Fbsxfun(), Fcell(), Fcell2struct(), fill_matrix(), Fresize(), Fstruct2cell(), get_dim_vector(), octave::get_dimensions(), octave_base_int_matrix< T >::load_ascii(), octave_bool_matrix::load_ascii(), octave_cell::load_ascii(), octave_complex_matrix::load_ascii(), octave_float_complex_matrix::load_ascii(), octave_float_matrix::load_ascii(), octave_matrix::load_ascii(), octave_char_matrix_str::load_ascii(), octave_struct::load_ascii(), octave_bool_matrix::load_binary(), octave_cell::load_binary(), octave_complex_matrix::load_binary(), octave_float_complex_matrix::load_binary(), octave_float_matrix::load_binary(), octave_matrix::load_binary(), octave_char_matrix_str::load_binary(), octave_struct::load_binary(), octave_base_int_matrix< T >::load_binary(), octave_bool_matrix::load_hdf5(), octave_cell::load_hdf5(), octave_complex_matrix::load_hdf5(), octave_float_complex_matrix::load_hdf5(), octave_float_matrix::load_hdf5(), octave_matrix::load_hdf5(), octave_char_matrix_str::load_hdf5(), octave_base_int_matrix< T >::load_hdf5_internal(), Array< T >::permute(), read_mat5_binary_element(), Sparse< T >::reshape(), single_type_concat(), Array< T >::sort(), Array< T >::squeeze(), and zero_dims_inquire().
|
inlineprivate |
Clone and resize this->rep to length n, filling by given value.
Definition at line 139 of file dim-vector.h.
References n, Array< T >::ndims(), r, and Array< T >::rep.
octave_idx_type dim_vector::safe_numel | ( | void | ) | const |
The following function will throw a std::bad_alloc () exception if the requested size is larger than can be indexed by octave_idx_type.
This may be smaller than the actual amount of memory that can be safely allocated on a system. However, if we don't fail here, we can end up with a mysterious crash inside a function that is iterating over an array using octave_idx_type indices.
Definition at line 115 of file dim-vector.cc.
References dim_max(), idx_max, n, ndims(), and rep.
Referenced by Array< T >::Array(), Sparse< T >::Sparse(), Array< T >::clear(), octave_base_sparse< T >::numel(), and Sparse< T >::numel().
dim_vector dim_vector::squeeze | ( | void | ) | const |
Definition at line 134 of file dim-vector.cc.
References as_row(), chop_all_singletons(), elem(), ndims(), and xelem().
Referenced by octave_map::squeeze().
std::string dim_vector::str | ( | char | sep = 'x' | ) | const |
Definition at line 85 of file dim-vector.cc.
References ndims(), retval, and xelem().
Referenced by Array< T >::Array(), do_bsxfun_op(), octave_char_matrix_str::edit_display(), octave_struct::edit_display(), octave_scalar_struct::edit_display(), octave::base_ve_model::edit_display_sub(), octave::err_nonconformant(), eval_error(), get_blkmm_dims(), octave::base_ve_model::make_description_text(), operator<<(), print_empty_nd_array(), octave_cell::print_raw(), octave_classdef::print_raw(), octave_struct::print_raw(), octave_scalar_struct::print_raw(), Sparse< T >::reshape(), octave::out_of_range::update_message(), octave::workspace_model::update_table(), and warn_array_as_logical().
|
inline |
Definition at line 257 of file dim-vector.h.
References Array< T >::rep.
Referenced by Array< T >::jit_dimensions().
|
inline |
Definition at line 227 of file dim-vector.h.
References Array< T >::rep.
Referenced by num_ones(), squeeze(), and str().
|
inline |
Definition at line 229 of file dim-vector.h.
References Array< T >::rep.
|
inline |
Definition at line 377 of file dim-vector.h.
References Array< T >::ndims(), and Array< T >::xelem().
Referenced by Array< T >::assign(), Array< T >::cat(), octave::tm_row_const::cellify(), octave::tm_row_const::init(), octave::tm_row_const::init_element(), and octave_base_value::is_zero_by_zero().
|
friend |
Definition at line 585 of file dim-vector.h.
|
private |
Definition at line 98 of file dim-vector.h.
Referenced by chop_all_singletons(), concat(), hvcat(), operator=(), redim(), and safe_numel().