GNU Octave  4.4.1
A high-level interpreted language, primarily intended for numerical computations, mostly compatible with Matlab
cellfun.cc File Reference
#include <string>
#include <vector>
#include <list>
#include <memory>
#include "lo-mappers.h"
#include "oct-locbuf.h"
#include "oct-string.h"
#include "Cell.h"
#include "oct-map.h"
#include "defun.h"
#include "interpreter.h"
#include "parse.h"
#include "variables.h"
#include "unwind-prot.h"
#include "errwarn.h"
#include "utils.h"
#include "ov-bool.h"
#include "ov-class.h"
#include "ov-colon.h"
#include "ov-complex.h"
#include "ov-float.h"
#include "ov-flt-complex.h"
#include "ov-int16.h"
#include "ov-int32.h"
#include "ov-int64.h"
#include "ov-int8.h"
#include "ov-scalar.h"
#include "ov-uint16.h"
#include "ov-uint32.h"
#include "ov-uint64.h"
#include "ov-uint8.h"
#include "ov-fcn-handle.h"
Include dependency graph for cellfun.cc:

Go to the source code of this file.

Macros

#define BTYP_BRANCH(X, Y)
 

Functions

then the function must return scalars which will be concatenated into the return array (s). If code
 
is the outputs are concatenated into a cell array(or cell arrays). For example endfunction cellfun ("factorial", -1, 2, "ErrorHandler", @foo) esult
 
OCTAVE_EXPORT octave_value_list Fcellfun (octave::interpreter &interp, const octave_value_list &args, int nargout) ots
 
static void get_mapper_fun_options (octave::symbol_table &symtab, const octave_value_list &args, int &nargin, bool &uniform_output, octave_value &error_handler)
 
static octave_value_list get_output_list (octave_idx_type count, octave_idx_type nargout, const octave_value_list &inputlist, octave_value &func, octave_value &error_handler)
 
 if (nargin< 2) print_usage()
 
 if (ptr_func) func
 
template<typename BNDA , typename NDA >
static octave_value_list try_cellfun_internal_ops (const octave_value_list &args, int nargin)
 

Variables

calling an anonymous function involves an overhead quite comparable to the overhead of an m file function Passing a handle to a built in function is because the interpreter is not involved in the internal loop For a
 
 b = twoouts (x) a = x
 
 else
 
 endfunction [aa, bb] = cellfun (@twoouts, 1, 2, 3) esult{} aa = 1 2 3 bb = 1 4 9 nd group nd example Note that per default the output argument(s) are arrays of the same size as the input arguments. Input arguments that are singleton (1x1) cells will be automatically expanded to the size of the other arguments. If the parameter code{"UniformOutput"} is set to true (the default)
 
calling an anonymous function involves an overhead quite comparable to the overhead of an m file function Passing a handle to a built in function is because the interpreter is not involved in the internal loop For example
 
is false
 
calling an anonymous function involves an overhead quite comparable to the overhead of an m file function Passing a handle to a built in function is faster
 
 however
 
nd group nd example Use ode {cellfun} intelligently. The ode{cellfun} function is a useful tool for avoiding loops. It is often used with anonymous function handles
 

Macro Definition Documentation

◆ BTYP_BRANCH

#define BTYP_BRANCH (   X,
 
)
Value:
case btyp_ ## X: \
retval = do_mat2cell (a.Y ## _value (), d, nargin - 1); \
break
F77_RET_T const F77_REAL const F77_REAL F77_REAL &F77_RET_T const F77_DBLE const F77_DBLE F77_DBLE &F77_RET_T const F77_DBLE F77_DBLE &F77_RET_T const F77_REAL F77_REAL &F77_RET_T const F77_DBLE const F77_DBLE F77_DBLE * d
calling an anonymous function involves an overhead quite comparable to the overhead of an m file function Passing a handle to a built in function is because the interpreter is not involved in the internal loop For a
Definition: cellfun.cc:400
args.length() nargin
Definition: file-io.cc:589

Function Documentation

◆ array()

◆ cellfun()

is the outputs are concatenated into a cell array (or cell arrays). For example endfunction cellfun ( "factorial"  ,
1,
,
"ErrorHandler"  ,
foo 
)

Definition at line 400 of file cellfun.cc.

◆ Fcellfun()

OCTAVE_EXPORT octave_value_list Fcellfun ( octave::interpreter interp,
const octave_value_list args,
int  nargout 
)

Definition at line 400 of file cellfun.cc.

◆ get_mapper_fun_options()

static void get_mapper_fun_options ( octave::symbol_table symtab,
const octave_value_list args,
int &  nargin,
bool uniform_output,
octave_value error_handler 
)
static

◆ get_output_list()

◆ if() [1/2]

if ( )

Definition at line 407 of file cellfun.cc.

Referenced by octave::load_path::files().

◆ if() [2/2]

if ( ptr_func  )

◆ try_cellfun_internal_ops()

Variable Documentation

◆ a

calling an anonymous function involves an overhead quite comparable to the overhead of an m file function Passing a handle to a built in function is because the interpreter is not involved in the internal loop For a

Definition at line 400 of file cellfun.cc.

Referenced by octave::main_window::add_action(), octave::file_editor::add_action(), octave::variable_editor::add_action(), HistoryScrollBuffer::addCells(), HistoryScrollBlockArray::addCells(), QtHandles::addEmptyAction(), aepbalance< T >::aepbalance(), octave::math::airy(), RowVector::append(), FloatRowVector::append(), ComplexRowVector::append(), FloatComplexRowVector::append(), Matrix::append(), FloatMatrix::append(), ComplexMatrix::append(), FloatComplexMatrix::append(), Array< octave_value >::Array(), Array< T >::ArrayRep::ArrayRep(), octave::math::biry(), bitshift(), axes::properties::calc_tick_sep(), octave::math::chol< T >::chol(), ComplexDiagMatrix::ComplexDiagMatrix(), ComplexMatrix::ComplexMatrix(), ComplexNDArray::ComplexNDArray(), conj(), octave::octave_qscintilla::contextMenuEvent(), conv_to_int_array(), convert_cdata(), convolve_nd(), octave::opengl_texture::create(), octave::file_editor::create_context_menu(), default_null_matrix_numeric_conversion_function(), default_null_sq_str_numeric_conversion_function(), default_null_str_numeric_conversion_function(), default_numeric_conversion_function(), default_numeric_demotion_function(), DiagArray2< Complex >::DiagArray2(), divide(), dmdm_div_impl(), dmdm_leftdiv_impl(), dmm_leftdiv_impl(), dmsolve(), dmsolve_insert(), dmsolve_permute(), do_add_dm_sm(), do_add_sm_dm(), do_commutative_add_dm_sm(), octave::math::do_erfcinv(), octave::math::do_erfinv(), do_extended_gcd(), octave_rand::do_float_nd_array(), octave_rand::do_float_scalar(), octave_rand::do_float_vector(), do_leftdiv_dm_sm(), do_mul_dm_sm(), do_mul_sm_dm(), do_mx_check(), octave_rand::do_nd_array(), do_rand(), do_rc_map(), do_rightdiv_sm_dm(), octave_rand::do_scalar(), do_simple_gcd(), do_sub_dm_sm(), do_sub_sm_dm(), do_tril(), do_trilu(), do_triu(), octave_rand::do_vector(), octave::opengl_renderer::draw_image(), octave::opengl_renderer::draw_patch(), octave::opengl_renderer::draw_surface(), EIG::EIG(), elem_xpow(), octave::math::ellipj(), QtHandles::Figure::eventNotifyAfter(), QtHandles::Figure::eventNotifyBefore(), extended_gcd(), F__betainc__(), F__gammainc__(), Faddeeva_w(), Fconv2(), Ffilter(), DiagMatrix::fill(), FloatDiagMatrix::fill(), ComplexDiagMatrix::fill(), FloatComplexDiagMatrix::fill(), octave_rand::fill(), filter(), octave_rand::float_nd_array(), octave_rand::float_scalar(), octave_rand::float_vector(), FloatComplexDiagMatrix::FloatComplexDiagMatrix(), FloatComplexMatrix::FloatComplexMatrix(), FloatComplexNDArray::FloatComplexNDArray(), FloatEIG::FloatEIG(), FloatMatrix::FloatMatrix(), FloatNDArray::FloatNDArray(), Fquad(), G__glpk__(), octave_sort< T >::gallop_left(), octave_sort< T >::gallop_right(), octave::math::gammainc(), octave::math::gepbalance< T >::gepbalance(), octave_sort< T >::MergeState::getmemi(), glpk(), octave::math::gsvd< T >::gsvd(), Gsymbfact(), EIG::hermitian_init(), FloatEIG::hermitian_init(), octave::math::hess< T >::hess(), ichol_mult_complex(), ichol_mult_real(), imag(), hess< T >::init(), gepbalance< T >::init(), qrp< T >::init(), schur< T >::init(), EIG::init(), FloatEIG::init(), octave::math::sparse_chol< chol_type >::sparse_chol_rep< chol_type >::init(), chol< T >::init(), qr< T >::init(), inner_do_add_sm_dm(), RowVector::insert(), boolMatrix::insert(), FloatRowVector::insert(), ColumnVector::insert(), FloatColumnVector::insert(), ComplexRowVector::insert(), ComplexColumnVector::insert(), FloatComplexColumnVector::insert(), FloatComplexRowVector::insert(), charMatrix::insert(), MSparse< Complex >::insert(), boolNDArray::insert(), charNDArray::insert(), SparseBoolMatrix::insert(), ComplexNDArray::insert(), FloatComplexNDArray::insert(), FloatMatrix::insert(), Matrix::insert(), FloatNDArray::insert(), intNDArray< OCTAVE_INT_T >::insert(), SparseMatrix::insert(), NDArray::insert(), ComplexMatrix::insert(), FloatComplexMatrix::insert(), SparseComplexMatrix::insert(), Cell::insert(), Sparse< bool >::insert(), Array< octave_value >::insert(), octave::symbol_table::is_superiorto(), lu< T >::lu(), magform(), QtHandles::Utils::makeImageFromCData(), mark_upper_triangular(), Matrix::Matrix(), matrix_complex_probe(), matrix_real_probe(), MatrixType::MatrixType(), max(), octave::maybe_compound_binary_expression(), maybe_optimized_builtin(), mdm_div_impl(), QtHandles::Menu::Menu(), min(), QtHandles::MouseModeActionGroup::MouseModeActionGroup(), mx_div_conform(), mx_el_and_assign(), mx_el_or_assign(), mx_leftdiv_conform(), octave_rand::nd_array(), NDArray::NDArray(), norm1(), oct_conv_bool_matrix_conv(), oct_conv_complex_diag_matrix_to_complex_matrix(), oct_conv_complex_matrix_conv(), oct_conv_diag_matrix_to_matrix(), oct_conv_float_complex_diag_matrix_to_complex_diag_matrix(), oct_conv_float_complex_matrix_conv(), oct_conv_float_diag_matrix_to_float_matrix(), oct_conv_matrix_conv(), oct_conv_perm_matrix_to_matrix(), oct_conv_range_to_matrix(), oct_conv_sparse_bool_matrix_conv(), oct_conv_sparse_complex_matrix_conv(), oct_conv_sparse_matrix_conv(), oct_fill_float_randg(), oct_fill_randg(), oct_float_randg(), oct_randg(), oct_unop_hermitian(), oct_unop_not(), oct_unop_scalar_transpose(), oct_unop_transpose(), oct_unop_uminus(), oct_unop_uplus(), octave_handle::octave_handle(), octave_value::octave_value(), octinternal_do_mul_colpm_sm(), octinternal_do_mul_pm_sm(), octinternal_do_mul_sm_colpm(), octinternal_do_mul_sm_pm(), octinternal_do_mul_sm_rowpm(), boolMatrix::operator!=(), RowVector::operator!=(), FloatRowVector::operator!=(), ColumnVector::operator!=(), FloatColumnVector::operator!=(), ComplexRowVector::operator!=(), ComplexColumnVector::operator!=(), DiagMatrix::operator!=(), FloatDiagMatrix::operator!=(), FloatComplexColumnVector::operator!=(), FloatComplexRowVector::operator!=(), charMatrix::operator!=(), ComplexDiagMatrix::operator!=(), SparseBoolMatrix::operator!=(), FloatComplexDiagMatrix::operator!=(), FloatMatrix::operator!=(), Matrix::operator!=(), SparseMatrix::operator!=(), ComplexMatrix::operator!=(), SparseComplexMatrix::operator!=(), FloatComplexMatrix::operator!=(), operator!=(), operator*(), operator*=(), operator+(), operator+=(), ComplexRowVector::operator+=(), ComplexColumnVector::operator+=(), FloatComplexRowVector::operator+=(), FloatComplexColumnVector::operator+=(), ComplexDiagMatrix::operator+=(), FloatComplexDiagMatrix::operator+=(), Matrix::operator+=(), FloatMatrix::operator+=(), ComplexMatrix::operator+=(), FloatComplexMatrix::operator+=(), operator-(), operator-=(), ComplexRowVector::operator-=(), ComplexColumnVector::operator-=(), FloatComplexRowVector::operator-=(), FloatComplexColumnVector::operator-=(), Matrix::operator-=(), FloatMatrix::operator-=(), ComplexMatrix::operator-=(), FloatComplexMatrix::operator-=(), operator/(), operator/=(), operator<(), operator<<(), operator<=(), base_minimizer::operator=(), ODE::operator=(), base_diff_alg_eqn::operator=(), DAE::operator=(), DAERT::operator=(), ODES::operator=(), octave::math::aepbalance< MT >::operator=(), base_diff_eqn::operator=(), ODEFunc::operator=(), octave::math::qrp< T >::operator=(), boolNDArray::operator=(), RowVector::operator=(), FloatRowVector::operator=(), ColumnVector::operator=(), DAERTFunc::operator=(), ComplexNDArray::operator=(), octave::math::lu< T >::operator=(), octave::math::gepbalance< T >::operator=(), FloatComplexNDArray::operator=(), FloatColumnVector::operator=(), octave_sparse_params::operator=(), octave::math::gsvd< T >::operator=(), octave::math::sparse_qr< SPARSE_T >::operator=(), base_det< T >::operator=(), intNDArray< OCTAVE_INT_T >::operator=(), ComplexRowVector::operator=(), charNDArray::operator=(), octave::math::chol< T >::operator=(), octave::math::hess< T >::operator=(), DAEFunc::operator=(), FloatNDArray::operator=(), DiagMatrix::operator=(), ComplexColumnVector::operator=(), FloatDiagMatrix::operator=(), FloatComplexColumnVector::operator=(), octave_handle::operator=(), octave::math::sparse_chol< chol_type >::operator=(), FloatComplexRowVector::operator=(), octave::math::qr< T >::operator=(), ODESFunc::operator=(), octave::math::svd< T >::operator=(), CollocWt::operator=(), NDArray::operator=(), octave::math::sparse_lu< lu_type >::operator=(), octave::math::schur< T >::operator=(), DiagArray2< Complex >::operator=(), MSparse< Complex >::operator=(), MDiagArray2< Complex >::operator=(), ComplexDiagMatrix::operator=(), SparseBoolMatrix::operator=(), FloatComplexDiagMatrix::operator=(), MArray< Complex >::operator=(), MatrixType::operator=(), SparseMatrix::operator=(), FloatEIG::operator=(), SparseComplexMatrix::operator=(), EIG::operator=(), Sparse< bool >::operator=(), Array< octave_value >::operator=(), octave_value::operator=(), idx_vector::operator=(), radio_values::operator=(), boolMatrix::operator==(), RowVector::operator==(), ColumnVector::operator==(), FloatRowVector::operator==(), FloatColumnVector::operator==(), ComplexRowVector::operator==(), DiagMatrix::operator==(), ComplexColumnVector::operator==(), FloatDiagMatrix::operator==(), FloatComplexRowVector::operator==(), FloatComplexColumnVector::operator==(), charMatrix::operator==(), ComplexDiagMatrix::operator==(), FloatComplexDiagMatrix::operator==(), SparseBoolMatrix::operator==(), FloatMatrix::operator==(), Matrix::operator==(), SparseMatrix::operator==(), ComplexMatrix::operator==(), SparseComplexMatrix::operator==(), FloatComplexMatrix::operator==(), operator==(), operator>(), operator>=(), operator>>(), symbol_info_list::parse_whos_line_format(), permute_vector_compare(), plus_or_minus(), pow(), powf(), print_descriptor(), product(), product_eq(), octave::math::qr< T >::qr(), qrp< T >::qrp(), octave::math::qrsolve(), quotient(), quotient_eq(), randu53(), read_mat5_binary_element(), read_sparse_matrix(), real(), axes::properties::rotate3d(), safe_comparator(), same_sign(), octave_rand::scalar(), scalar_xpow(), octave::math::schur< T >::schur(), octave::math::select_ana(), octave::math::select_dig(), SelfListener::SelfListener(), QtHandles::Figure::showMenuBar(), simple_gcd(), octave::simplify_ldiv_op(), octave::simplify_mul_op(), octave::math::sparse_qr< SPARSE_T >::solve(), Sparse< bool >::Sparse(), sparse_ascending_compare(), sparse_ascending_compare< Complex >(), sparse_ascending_compare< double >(), octave::math::sparse_chol< chol_type >::sparse_chol_rep< chol_type >::sparse_chol_rep(), sparse_descending_compare(), sparse_descending_compare< Complex >(), sparse_descending_compare< double >(), octave::math::sparse_lu< lu_type >::sparse_lu(), octave::math::sparse_qr< SPARSE_T >::sparse_qr_rep< SPARSE_T >::sparse_qr_rep(), SparseComplexMatrix::SparseComplexMatrix(), SparseMatrix::SparseMatrix(), Sparse< T >::SparseRep::SparseRep(), ColumnVector::stack(), FloatColumnVector::stack(), ComplexColumnVector::stack(), FloatComplexColumnVector::stack(), Matrix::stack(), FloatMatrix::stack(), ComplexMatrix::stack(), FloatComplexMatrix::stack(), str_data_cmp(), str_data_cmpi(), octave::math::svd< T >::svd(), Sylvester(), EIG::symmetric_init(), FloatEIG::symmetric_init(), times_or_divide(), times_or_divides(), octave::tree_classdef_attribute_list::tree_classdef_attribute_list(), MatrixType::type(), umul128(), QtHandles::Menu::update(), QtHandles::Menu::updateSiblingPositions(), octave_rand::vector(), octave::tree_evaluator::visit_binary_expression(), octave::tree_evaluator::visit_boolean_expression(), octave::tree_evaluator::visit_compound_binary_expression(), x_el_div(), xdiv(), xgemm(), xleftdiv(), xpow(), and octave_sort< T >::MergeState::~MergeState().

◆ b

b = twoouts (x) a = x

Definition at line 400 of file cellfun.cc.

Referenced by HistoryScrollBlockArray::addCells(), base_det< T >::base_det(), SparseMatrix::bsolve(), SparseComplexMatrix::bsolve(), octave::math::sparse_qr< SPARSE_T >::C(), octave::math::sparse_qr< SPARSE_T >::sparse_qr_rep< SPARSE_T >::C(), axes::properties::calc_tick_sep(), color_values::color_values(), octave::jit_infer::construct_ssa(), convolve_nd(), divide(), dmsolve(), dmsolve_insert(), dmsolve_permute(), octave::math::do_erfcinv(), octave::math::do_erfinv(), do_extended_gcd(), do_simple_gcd(), SparseMatrix::dsolve(), SparseComplexMatrix::dsolve(), EIG::EIG(), EigsComplexNonSymmetricMatrix(), EigsComplexNonSymmetricMatrixShift(), EigsRealNonSymmetricMatrix(), EigsRealNonSymmetricMatrixShift(), EigsRealSymmetricMatrix(), EigsRealSymmetricMatrixShift(), elem_xpow(), octave::math::ellipj(), extended_gcd(), F__betainc__(), Fconv2(), Ffilter(), filter(), octave::jit_convert::finish_breaks(), FloatEIG::FloatEIG(), Fquad(), Matrix::fsolve(), FloatMatrix::fsolve(), ComplexMatrix::fsolve(), FloatComplexMatrix::fsolve(), SparseMatrix::fsolve(), SparseComplexMatrix::fsolve(), G__glpk__(), octave::math::gepbalance< T >::gepbalance(), HistoryScrollBlockArray::getCells(), glpk(), octave::math::gsvd< T >::gsvd(), octave::octave_dock_widget::handle_settings(), EIG::hermitian_init(), FloatEIG::hermitian_init(), ichol_mult_complex(), ichol_mult_real(), idx_vector::idx_range_rep::idx_range_rep(), gepbalance< T >::init(), EIG::init(), FloatEIG::init(), octave::symbol_table::is_superiorto(), Matrix::lssolve(), FloatMatrix::lssolve(), ComplexMatrix::lssolve(), FloatComplexMatrix::lssolve(), Matrix::ltsolve(), FloatMatrix::ltsolve(), SparseMatrix::ltsolve(), SparseComplexMatrix::ltsolve(), ComplexMatrix::ltsolve(), FloatComplexMatrix::ltsolve(), LuAminusSigmaB(), magform(), main(), make_cholb(), QtHandles::Utils::makeImageFromCData(), Range::matrix_value(), max(), octave::maybe_compound_binary_expression(), maybe_optimized_builtin(), min(), mx_div_conform(), mx_el_and_assign(), mx_el_or_assign(), mx_leftdiv_conform(), intNDArray< OCTAVE_INT_T >::operator!(), boolMatrix::operator!(), operator!=(), operator*(), operator+(), operator+=(), operator-(), operator-=(), operator<(), operator<<(), operator<=(), graphics_toolkit::operator=(), operator==(), operator>(), operator>=(), symbol_info_list::parse_whos_line_format(), permute_vector_compare(), plus_or_minus(), pow(), powf(), print_descriptor(), octave_fcn_handle::print_raw(), octave::news_reader::process(), product(), product_eq(), octave::jit_block_list::push_back(), octave::math::qrsolve(), quotient(), quotient_eq(), randu53(), Range::Range(), octave::jit_infer::remove_dead(), octave::opengl_renderer::render_ticktexts(), Screen::reverseRendition(), same_sign(), octave_struct::save_ascii(), octave_cell::save_ascii(), octave_class::save_ascii(), octave_scalar_struct::save_ascii(), octave_struct::save_binary(), octave_cell::save_binary(), octave_class::save_binary(), octave_scalar_struct::save_binary(), scalar_xpow(), octave::math::select_dig(), figure::properties::set___graphics_toolkit__(), Range::set_base(), ODESFunc::set_bsub_function(), figure::properties::set_toolkit(), TerminalModel::setAutoClose(), Vt102Emulation::setMargins(), octave::tree_evaluator::silent_functions(), simple_gcd(), octave::simplify_mul_op(), octave::math::sparse_qr< SPARSE_T >::solve(), Matrix::solve(), FloatMatrix::solve(), ComplexMatrix::solve(), FloatComplexMatrix::solve(), SparseMatrix::solve(), SparseComplexMatrix::solve(), sparse_ascending_compare(), sparse_ascending_compare< Complex >(), sparse_ascending_compare< double >(), sparse_descending_compare(), sparse_descending_compare< Complex >(), sparse_descending_compare< double >(), str_data_cmp(), str_data_cmpi(), Sylvester(), EIG::symmetric_init(), FloatEIG::symmetric_init(), octave::math::sparse_qr< SPARSE_T >::tall_solve(), octave::math::sparse_qr< SPARSE_T >::sparse_qr_rep< SPARSE_T >::tall_solve(), text_element_color::text_element_color(), SparseMatrix::trisolve(), SparseComplexMatrix::trisolve(), SparseMatrix::utsolve(), Matrix::utsolve(), FloatMatrix::utsolve(), SparseComplexMatrix::utsolve(), ComplexMatrix::utsolve(), FloatComplexMatrix::utsolve(), octave::jit_convert_llvm::visit(), octave::tree_evaluator::visit_binary_expression(), octave::tree_evaluator::visit_boolean_expression(), octave::tree_evaluator::visit_compound_binary_expression(), octave::math::sparse_qr< SPARSE_T >::wide_solve(), octave::math::sparse_qr< SPARSE_T >::sparse_qr_rep< SPARSE_T >::wide_solve(), x_el_div(), xdiv(), xgemm(), xleftdiv(), and xpow().

◆ else

else
Initial value:
{
func = symtab.find_function (name)
nd deftypefn *std::string name
Definition: sysdep.cc:647

Definition at line 441 of file cellfun.cc.

◆ endfunction

if (! args(1).iscell ()) error ("cellfun endfunction = cellfun (@twoouts, 1, 2, 3) esult{} aa = 1 2 3 bb = 1 4 9 nd group nd example Note that per default the output argument(s) are arrays of the same size as the input arguments. Input arguments that are singleton (1x1) cells will be automatically expanded to the size of the other arguments. If the parameter code{"UniformOutput"} is set to true (the default)

Definition at line 400 of file cellfun.cc.

◆ example

identity matrix If supplied two scalar respectively For example

Definition at line 400 of file cellfun.cc.

◆ false

◆ faster

calling an anonymous function involves an overhead quite comparable to the overhead of an m file function Passing a handle to a built in function is faster

Definition at line 400 of file cellfun.cc.

◆ however

however

Definition at line 400 of file cellfun.cc.

◆ ode

or ode {cellfun} intelligently. The ode{cellfun} function is a useful tool for avoiding loops. It is often used with anonymous function handles

Definition at line 400 of file cellfun.cc.

Referenced by Flsode().