view main/INDEX @ 2781:c12d3a7775e8 octave-forge

Update INDEX files for new functions
author adb014
date Sun, 03 Dec 2006 21:54:09 +0000
parents dd9aa4039f72
children dbd461601367
line wrap: on
line source

# This is the main index of functions in octave/octave-forge.
# It organizes functions by toolbox and by category within
# each toolbox.  Individual directories may have their own
# INDEX file specifying their own toolboxes, or their own
# categories within the "extra" toolbox.  In general if you
# are adding a function to a directory and it does not already
# have an INDEX file, then you should add it here.  If you
# are adding a new directory, you should probably add a new
# INDEX file.

# An index file has the following format:
#
#  toolbox >> Toolbox name
#  Category Name
#   fn fn fn
#   fn fn fn
#  Category Name
#   fn

# Toolbox and category definitions are on the left, function
# lists are indented.

# If no toolbox is specified, then the categories will go into
# extra.  Only use this if you are contributing a small number
# of specialized functions.

# Lines starting with # are comment lines.

# Some functions may be unavailable in octave or octave-forge.
# If they are not implemented they can be listed as usual
# and they will show up with a description of "not implemented".
# If there is a work around or if the function is available
# elsewhere, you can instead use:
#  fn = workaround description
# This workaround description can use any html markup, but
# keep in mind that it is in a bold-italic environment.  For
# the special case of:
#  fn = use <code>alternate expression</code>
# the bold-italic is automatically suppressed.  You will need
# to use <code> even in references:
#  fn = use <a href="someothersite.html"><code>fn</code></a>
# Sometimes functions are only partially compatible, in which
# case you can list the non-compatible cases separately. To
# refer to another function in the package, use <f>fn</f>.
# E.g.,
#  eig(A,B) = use <f>qz</f>

# Since sites may have many missing functions, you can define
# a macro rather than typing the same link over and again.
#  $id = expansion
# defines the macro id.  You can use $id anywhere in the
# description and it will be expanded.  E.g.,
#  $TSA = see <a href="link_to_spctools">SPC Tools</a>
#  arcov = $TSA <code>armcv</code>
# id is any string of letters, numbers and _.

audio >> Audio
Record and play
 speak 
 recordsound 
 wavrecord 
 soundcap 
 loadaudio saveaudio playaudio record setaudio
Read and write
 wavwrite 
 wavread 
 readsnd 
 writesnd 
Process
 mu2lin 
 lin2mu

interpreter >> Interpreter
Help
 help
 doc 
 demo 
 ver
 version 
Variables
 who 
 whos
 whos_line_format 
 workspace 
 clear 
 pack 
 load 
 save 
 append_save
 quit
 document
 temp_name
 class
Functions
 autoload
 alias
 what 
 type
 isa 
 dispatch
 edit 
 open 
 lookfor 
 which 
 pcode 
 inmem = use <f>who</f> with -functions
 mex
 mexext
 source
 mark_as_command unmark_command
 mark_as_rawcommand unmark_rawcommand
 iscommand israwcommand
Load path
 path 
 addpath 
 savepath
 rmpath 
 pathtool 
 file_in_path file_in_loadpath
 rehash
 genpath
 pathdef
Output
 echo 
 more 
 diary 
 format
 terminal_size
 list_in_columns 
Environment
 cd pwd
 dir
 ls
 ls_command
 mkdir isdir
 copyfile= use <f>system</f><code>("[cp ", source, " ", dest])</code>
 delete
 getenv 
 putenv
 dos
 vms= use <f>system</f>
 unix
 web 
 computer 
 isieee
 isunix ispc
 system
 ! = use <f>system</f><code>("command")</code>
 dump_prefs
 bug_report warranty
 native_float_format
 license ver
 uname
 extproc
Debugging
 dbclear
 dbstatus
 dbstop
 dbtype
 dbwhere
 debug_on_error
 debug_on_interrupt
 debug_on_warning
 debug_symtab_lookups
Installation
 mkoctfile mex tar untar zip unzip pkg
 bunzip2 gunzip unpack
 compare_versions movefile 
Profiling
 profile 
 flops 
Demos and Tests.
 example  demo  test  assert  fail speed 

variables >> System Configuration Variables
Command input
 history history_file history_size edit_history
 saving_history run_history read_readline_init_file
 completion_append_char completion_matches
 history_timestamp_format_string
Function
 ignore_function_time_stamp
Display
 echo_executing_commands
 page_screen_output page_output_immediately
 print_answer_id_name print_empty_dimensions print_rhs_assign_val
 struct_levels_to_print
 split_long_rows silent_functions
 suppress_verbose_help_message
 output_max_field_width output_precision
 PS1 PS2 PS4 fixed_point_format
Error Handling
 crash_dumps_octave_core
 octave_core_file_options
 octave_core_file_limit
 octave_core_file_name
 beep_on_error
 debug_on_error
 debug_on_warning
 errno
 errno_list
 warning_ids
Processing
 variables_can_hide_functions
 max_recursion_depth
 string_fill_char
 casesen
 sighup_dumps_octave_core
 sigterm_dumps_octave_core
File output
 default_save_options
 save_precision
 save_header_format_string
Support programs
 EDITOR 
 info_file info_program makeinfo_program
 PAGER gnuplot_binary
 PAGER_FLAGS
Constants
 F_DUPFD F_GETFD F_GETFL F_SETFD F_SETFL
 O_APPEND O_ASYNC O_CREAT O_EXCL O_NONBLOCK O_RDONLY
 O_RDWR O_SYNC O_TRUNC O_WRONLY
 SEEK_CUR SEEK_END SEEK_SET
 OCTAVE_HOME OCTAVE_VERSION
 octave_config_info
 program_name argv
 program_invocation_name
Variables
 EXEC_PATH IMAGE_PATH

system >> System Utilities
Clock functions
 now 
 date 
 clock 
 cputime 
 tic 
 toc 
 etime gmtime
 ctime time localtime mktime
Date conversion
 is_leap_year
 asctime
 datenum 
 datestr 
 datevec 
 weekday 
 eomday 
 calendar 
 datetick=use <code>gset xdata time; gset timefmt "%d/%m"; gset format x "%b %d"</code>
 strftime 
 strptime
Controlling subprocesses
 system
 popen popen2 pclose
 fork exec pipe waitpid kill
 EXEC_PATH sleep usleep
 WCONTINUE
 WCOREDUMP
 WEXITSTATUS
 WIFCONTINUED
 WIFEXITED
 WIFSIGNALED
 WIFSTOPPED
 WNOHANG
 WSTOPSIG
 WTERMSIG
 WUNTRACED
 SIG
Process information
 getrusage
 getpgrp
 getpid
 getppid
 geteuid
 getuid
 getegid
 getgid
 getgrgid
Password Database
 getpwent
 getpwuid
 getpwnam
 setpwent
 endpwent
Group Database
 getgrent
 getgrnam
 setgrent
 endgrent

language >> Programming
Logical functions
 xor 
 any 
 all 
 true
 false
 isbool
Bit operations
 bitand 
 bitcmp 
 bitor 
 bitmax 
 bitxor 
 bitset 
 bitget 
 bitshift
 intmax
 intmin 
Sets
 union 
 unique create_set
 intersect intersection
 setdiff  complement
 setxor 
 ismember 
Control structures
 if 
 else 
 elseif 
 end 
 for 
 while 
 break 
 switch 
 case 
 otherwise 
 try 
 catch 
 return 
Interpreter interface
 iskeyword isvarname
 eval 
 evalc 
 feval
 leval temp_name
 evalin 
 builtin 
 assignin 
 ans 
 input_event_hook atexit 
 func2str str2func functions
Constants
 eps 
 realmax 
 realmin 
 pi e
 i j I J
 Inf inf isinf
 isfinite finite
 NaN nan isnan 
 NA isna
Symbol table
 exist
 global
 isglobal
 static
 persistent
 mfilename 
 mlock 
 munlock 
 mislocked
 command typeinfo
Function arguments
 nargchk 
 nargin 
 nargout 
 varargin
 varargout
 inputname
 fcnchk 
 read_options
 usage
 argn = string names of the input parameters
 parseparams
User I/O
 disp printf puts
 print_usage
 error 
 warning 
 lasterr 
 lastwarn 
 clc 
 home 
 input 
 keyboard kbhit
 pause menu
 waitbar beep
 yes_or_no
Inline functions
 inline
 argnames 
 formula 
 char 
 vectorize 
Cell arrays
 cell 
 iscell 
 deref
 cellfun 
 celldisp 
 cellplot 
 num2cell 
 deal
 cell2mat 
 cell2struct 
 struct2cell 
 mat2cell
Structures
 struct 
 fieldnames 
 getfield 
 setfield 
 rmfield 
 isfield 
 isstruct
 struct_contains
 struct_elements
 orderfields
Lists
 list islist
 nth
 append
 reverse
 splice
 leval
 map
Operations
 comma horzcat semicolon vertcat not paren cat
Types
 sparse cell struct 
 int8 int16 int32 int64
 uint8 uint16 uint32 uint64
 sizeof
Deprecated
  is_bool is_complex is_list is_stream is_struct is_global

matrix >> Linear Algebra
Generating matrices
 zeros 
 ones 
 eye 
 rand texas_lotto
 randn rande randg randp
 linspace 
 logspace 
 randperm
 meshgrid meshdom
 ndgrid
Matrix properties
 size rows columns common_size ndims
 length 
 isempty 
 isequal 
 isnumeric iscomplex
 islogical isdefinite
 logical 
 isscalar isvector ismatrix issquare 
 issymmetric is_duplicate_entry isequalwithequalnans
 size_equal
Assignment
 subsasgn subsref
 substruct
Rearranging matrices
 reshape 
 resize
 tril 
 triu 
 fliplr 
 flipud 
 flipdim
 rot90 
 rotdim
 repmat 
 diag 
 blkdiag 
 kron 
 find 
 sub2ind 
 ind2sub 
 transpose ctranspose
 prepad postpad shift vec vech
 permute ipermute squeeze numel
 circshift shiftdim
Special matrices
 compan 
 commutation_matrix
 duplication_matrix
 sylvester_matrix
 hankel 
 hilb 
 invhilb 
 lauchli
 magic 
 pascal 
 rosser 
 toeplitz 
 vander 
 wilkinson 
 $TESTMAT= available in Nick Higham's <a href="http://www.ma.man.ac.uk/~higham/testmat.html">Test Matrix Toolbox</a>
 gallery= $TESTMAT
 hadamard
Linear algebra
 dmult
 cross 
 dot
 norm 
 rank 
 det 
 trace 
 null 
 orth 
 rref 
 subspace=use Andrew Knyazev's <a href="ftp://ftp.mathworks.com/pub/contrib/v5/linalg/subspace.m"><code>subspace</code></a>
 cond 
 inv inverse 
 pinv 
 lscov 
 eig 
 eig(A,B)= use <f>qz</f>
 polyeig 
 condeig 
 syl
Matrix factorization
 chol 
 lu 
 qr 
 svd 
 hess 
 qz 
 schur 
 rsf2csf 
 cdf2rdf 
 balance 
 qrdelete 
 qrinsert 
 planerot 
 cholupdate
 chol2inv
 cholinv 
 qrupdate 
 housh
 krylov
 krylovb
 qzhess
 givens
Matrix functions
 expm 
 logm 
 sqrtm 
 funm thfm
Deprecated
 is_scalar is_matrix is_square is_symmetric is_vector

sparse >> Sparse matrix support
Generate sparse matrix
 speye 
 sprand 
 sprandn 
 sprandsym 
 spdiags 
 spconvert 
 spvcat sphcat
Manipulate sparse matrices
 sparse issparse 
 full
 issparse
 spy 
 nnz 
 spfind spdump
 nonzeros 
 nzmax 
 spones 
 spfun 
 spalloc 
 spkron
 matrix_type
Graph Theory
 etree
 etreeplot
 gplot
 treelayout
 treeplot
Sparse matrix reordering
 ccolamd
 colamd
 colperm
 csymamd
 dmperm
 randperm
 symamd
 symrcm
Linear algebra
 condest
 eigs
 normest
 spchol
 spchol2inv
 spcholinv
 spdet
 spinv 
 splchol
 splu
 spqr
 sprank
 svds= create an interface to <a href="http://www.caam.rice.edu/software/ARPACK/">ARPACK</a> and add it to octave-forge
Iterative techniques
 bicgstab
 cgs
 cholinc
 gmres
 lsqr
 luinc
 minres
 pcg
 pcr
 qmr
 symmlq
Miscellaneous
 spaugment
 spparms 
 symbfact
 spstats
 spprod
 spcumprod
 spcumsum
 spsum
 spsumsq
 spmin
 spmax
 spatan2
 spdiag

strings >> Strings
Creation
 char 
 double 
 cellstr 
 blanks 
 single
 cast
Tests
 ischar
 iscellstr 
 isletter 
 isspace 
 isalnum
 isalpha
 isascii
 iscntrl
 isdigit
 isgraph
 islower
 isprint
 ispunct
 isstr
 isupper
 isxdigit
Search and replace
 strmatch 
 fnmatch
 regexp
 regexpi
 regexprep
 strcmp
 strncmp 
 strcmpi 
 strncmpi 
 findstr strfind
 index rindex
 strrep
 substr
 cellidx
Operations
 deblank split 
 strcat 
 strvcat 
 strcmp 
 strjust 
 strtok 
 upper 
 lower 
 tolower
 toupper
 do_string_escapes
 undo_string_escapes
 strappend
 strsort
 strtrunc
Conversion
 toascii setstr
 num2str com2str str2mat
 str2num strftime
 mat2str 
 int2str 
 str2double 
 sprintf 
 sscanf 
 hex2num 
 hex2dec 
 bin2dec 
 base2dec 
 dec2hex 
 dec2bin 
 dec2base 
 strptime
 base64encode
Flags
 string_fill_char

math >> Mathematics
Trigonometry
 sin 
 sinh 
 asin 
 asinh 
 cos 
 cosh 
 acos 
 acosh 
 tan 
 tanh 
 atan 
 atan2 
 atanh 
 sec 
 sech 
 asec 
 asech 
 csc 
 csch 
 acsc 
 acsch 
 cot 
 coth 
 acot 
 acoth 
Exponentials
 exp 
 log 
 log10 
 log2 
 pow2 
 sqrt 
 nextpow2 
 nthroot
Complex numbers
 abs 
 angle arg
 complex 
 conj 
 imag 
 real 
 unwrap 
 isreal 
 cplxpair 
Floating point operations
 fix 
 floor 
 ceil 
 round 
 sign 
Special functions
 airy 
 besselj 
 bessely 
 besselh 
 besseli 
 besselk  bessel 
 beta 
 betainc  betai
 betaln 
 ellipj 
 ellipke 
 erf 
 erfc 
 erfcx 
 erfinv 
 expint 
 gamma
 gamma(complex)= use Tim Reluga's <a href="http://www.octave.org/mailing-lists/octave-sources/2002/9">Gamma.m</a> or Eyal Doron's <a href="http://www.octave.org/mailing-lists/octave-sources/1996/3">cgamma.m</a>
 gammainc gammai
 gammaln lgamma 
 lambertw
 legendre 
Number theory
 mod fmod
 rem 
 factor 
 isprime 
 primes list_primes
 gcd 
 lcm 
 rat 
 rats 
 perms 
 nchoosek bincoeff 
 factorial 
 SHA1
Coordinate transformations
 cart2sph 
 cart2pol 
 pol2cart 
 sph2cart 
 deg2rad rad2deg azimuth distance

analysis >> Data analysis
Sorting
 sort 
 sortrows 
Filtering
 filter 
 filter2 
 conv fftconv
 conv2 
 convn 
 deconv 
 detrend center clip
Fourier analysis
 fft fftw_wisdom
 fft2 
 fftn 
 ifft 
 ifft2 
 ifftn 
 fftshift 
 ifftshift
 fftw_wisdom_program
Interpolation
 bicubic
 interp1 
 interpft 
 interp2 
 interp3 
 interpn 
 pchip pchip_deriv
 lookup
Spline functions
 spline 
 ppval
 mkpp 
 unmkpp 
Geometry
 delaunay 
 delaunay3
 delaunayn
 dsearch 
 dsearchn
 tsearch 
 convhull 
 convhulln
 voronoi 
 voronoin
 griddata 
 griddata3
 griddatan
 inpolygon=  use David Doolin's <a href="http://www.che.wisc.edu/octave/mailing-lists/octave-sources/1999/12">inpoly.m</a>, but with <a href="http://www.che.wisc.edu/octave/mailing-lists/octave-sources/1999/13">caveats</a>

 rectint 
 polyarea 
 __voronoi__
Polynomials
 cheb
 roots 
 poly 
 polyval 
 polyvalm 
 residue
 residue(r,p,k)=use Bradley T. Burchett's <code><a href="ftp://ftp.mathworks.com/pub/contrib/v5/control/resid2wp.m">resid2wp</a></code>
 polyfit 
 polyder polyderiv
 polyinteg polyreduce polyout polygcd
Quaternions
 quaternion
 demoquat qconj qcoordinate_plot qderiv qderivmat qinv qmult
 qtrans qtransv qtransvmat

calculus >> Calculus
Integration
 quad 
 quadl
 quad8 
 dblquad 
 quad_options
 count cquadnd crule crule2d crule2dgen
 gquad gquad2d gquad2d6 gquad2dgen gquad6 gquadnd
 grule grule2d grule2dgen innerfun ncrule quad2dc
 quad2dcgen quad2dg quad2dggen quadc quadg quadndg
Differentiation
 diff 
 gradient 
 del2 
Ordinary differential equations
 ode23 ode45 ode78
 penddot
 pendulum
 rk2fixed rk4fixed rk8fixed
 lsode lsode_options
 dassl dassl_options
 daspk daspk_options
 dasrt dasrt_options
 lpsolve lpsolve_options
 colloc

plot >> Plotting
Line plots
 plot mplot fplot
 plot3 
 loglog 
 semilogx 
 semilogy 
 polar 
 plotyy= use <f>__gnuplot_raw__</f> with <code> ... axes x1y2</code>
 errorbar semilogxerr semilogyerr loglogerr
 scatter 
 plotmatrix 
 stem 
 stem3 
 stairs 
 comet 
 feather 
Business graphs
 pie 
 pie3 
 area 
 bar dhbar
 barh 
 bar3 
 bar3h 
 ribbon 
 pareto 
 fill 
Contour plots
 contour 
 contourf 
 contour3 
 clabel 
 pcolor 
Surface plots
 mesh 
 surf 
 comet3 
 quiver 
 meshc 
 meshz 
 scatter3 
 surfc 
 trisurf 
 trimesh 
 waterfall 
 fill3 
 sombrero
 peaks

plot >> Plot controls
Figure controls
 newplot 	 
 figure 	 
 clf 	 
 shg 	 
 close 	 
 refresh= try <f>replot</f>
 drawnow
 automatic_replot clearplot closeplot
 clg
 replot
Axis controls
 axis
 box 
 grid 
 hold 
 ishold 
 subplot 
 multiplot subwindow oneplot plot_border
 datetick
 tics
Labels
 title bottom_title top_title
 xlabel 
 ylabel 
 zlabel 
 legend 
 colorbar 
 texlabel 
 gtext 
Primitives
 text 
 patch 
Printing
 print 
 printopt 
 orient 
 dxfwrite

Colour controls
 colormap 
 spinmap 
 rgbplot 
 caxis 
 brighten 
Colour maps
 gray 
 ocean
 hsv rainbow
 hot 
 bone 
 copper 
 pink 
 white 
 flag 
 jet 
 prism 
 cool 
 autumn 
 spring 
 winter 
 summer 
 lines 
 colorcube 
 vga 
 contrast 
 colorgradient
View control
 view 
 viewmtx 
 rotate3d 
User input
 ginput gget grab gzoom gpick
 dragrect 
 rbbox 
Gnuplot Interface
 gnuplot_binary
 gnuplot_command_axes gnuplot_command_end gnuplot_command_plot
 gnuplot_command_replot gnuplot_command_splot gnuplot_command_title
 gnuplot_command_using gnuplot_command_with purge_tmp_files
 gnuplot_use_title_option
 __gnuplot_raw__ __gnuplot_set__ __gnuplot_show__ __gnuplot_plot__
 __gnuplot_splot__ __gnuplot_replot__

file >> File I/O
Basic handle operations
 fopen 
 fclose 
 fread 
 fwrite 
 ferror perror strerror
 feof 
 fseek 
 ftell 
 frewind 
 fflush
 freport
 dup2
 fcntl
 stdin stdout stderr
 isstreamoff streamoff
 fclear
Formatted I/O
 fgetl 
 fgets 
 fputs
 fprintf
 fdisp
 fscanf 
 scanf
File operations
 fileattrib
 tempdir 
 mkstemp
 tmpfile
 tmpnam
 tempname
 P_tmpdir
 prefdir 
 rename link unlink symlink readlink 
 mkfifo umask stat lstat
 mark_for_deletion
 S_ISBLK
 S_ISCHR
 S_ISDIR
 S_ISFIFO
 S_ISLNK
 S_ISREG
 S_ISSOCK
Directory operations
 cd pwd ls dir
 filesep 
 pathsep 
 fullfile 
 fileparts 
 partialpath 
 readdir mkdir rmdir
 glob
 tilde_expand
 file_in_path
 file_in_loadpath
 canonicalize_file_name
 confirm_recursive_rmdir
Import/Export
 csv2cell cell2csv
 textread
 dlmread dlmwrite 
 csvread csvwrite
 xmlread xmlwrite xlsread
 wk1read wk1write 
 wavread wavwrite
 auload ausave
 imread imwrite
 hdf = use <f>load</f>/<f>save</f> with <code>-hdf5</code>
 aload/asave= flat ascii file read/write, available from <a href="ftp://ftp.ci.tuwien.ac.at/pub/octave/octave-ci.tar.gz">Octave-ci</a>

optimization >> Optimization
Linear programming
 glpk
 sqp
 qp
 glpkmex

finance >> Finance
Finance
 fv fvl irr nper npv pmt pv pvl rate vol

statistics >> Statistics
Depreciated
 beta_cdf beta_inv beta_pdf beta_rnd
 binomial_cdf binomial_inv binomial_pdf binomial_rnd
 chisquare_cdf chisquare_inv chisquare_pdf chisquare_rnd
 exponential_cdf exponential_inv exponential_pdf exponential_rnd
 f_cdf f_inv f_pdf f_rnd
 gamma_cdf gamma_inv gamma_pdf gamma_rnd
 geometric_cdf geometric_inv geometric_pdf geometric_rnd
 hypergeometric_cdf hypergeometric_inv hypergeometric_pdf hypergeometric_rnd
 lognormal_cdf lognormal_inv lognormal_pdf lognormal_rnd
 normal_cdf normal_inv normal_pdf normal_rnd
 poisson_cdf poisson_inv poisson_pdf poisson_rnd
 t_cdf t_inv t_pdf t_rnd
 uniform_cdf uniform_inv uniform_pdf uniform_rnd
 wblcdf wblinv wblpdf wblrnd
 weibull_cdf weibull_inv weibull_pdf weibull_rnd
 wiener_rnd 
Distributions
 betacdf betainv betapdf betarnd
 binocdf binoinv binopdf binornd
 cauchy_cdf cauchy_inv cauchy_pdf cauchy_rnd
 chi2cdf chi2inv chi2pdf chi2rnd
 discrete_cdf discrete_inv discrete_pdf discrete_rnd
 empirical_cdf empirical_inv empirical_pdf empirical_rnd
 expcdf expinv exppdf exprnd
 fcdf finv fpdf frnd
 gamcdf gaminv gampdf gamrnd
 geocdf geoinv geopdf geornd
 hygecdf hygeinv hygepdf hygernd
 kolmogorov_smirnov_cdf
 laplace_cdf laplace_inv laplace_pdf laplace_rnd
 logistic_cdf logistic_inv logistic_pdf logistic_rnd
 logncdf logninv lognpdf lognrnd
 normcdf norminv normpdf normrnd
 pascal_cdf pascal_inv pascal_pdf pascal_rnd
 poisscdf poissinv poisspdf poissrnd
 stdnormal_cdf stdnormal_inv stdnormal_pdf stdnormal_rnd
 tcdf tinv tpdf trnd
 unidrnd
 unifcdf unifinv unifpdf unifrnd
 weibcdf weibinv weibpdf weibrnd
 wienrnd
Descriptive statistics
 max 
 min 
 mean meansq
 median 
 std 
 var 
 cut hist
 histc 
 corrcoef 
 cov cor
 sum sumsq 
 prod 
 trapz 
 cumsum 
 cumprod 
 cumtrapz 
 nanfunc
 iqr		
 kurtosis	
 moment	
 range	
 skewness	
 spearman
 run_count
 statistics
 studentize
 table
 values mahalanobis
 ranks
 probit logit kendall cloglog
Experimental design
 fullfact ff2n hadamard
Linear regression
 anova anovan
 polyfit wpolyfit	
 polyval polyconf	
 gls ols wsolve
 princomp
Plots
 qqplot ppplot boxplot scatter normplot 
 pareto 
 histfit
Nonlinear regression
 leasqr	
Models
 hmmdecode
 logistic_regression logistic_regression_derivatives 
 logistic_regression_likelihood
Hypothesis testing
 u_test	
 wilcoxon_test	
 sign_test	
 t_test	
 t_test_2	
 t_test_regression
 z_test	
 z_test_2
 bartlett_test
 chisquare_test_homogeneity
 chisquare_test_independence
 cor_test
 f_test_regression
 hotelling_test
 hotelling_test_2
 kolmogorov_smirnov_test
 kolmogorov_smirnov_test_2
 kruskal_wallis_test
 manova
 mcnemar_test
 prop_test_2
 run_test
 var_test
 welch_test
Compatibility
 nbin*= use <code>pascal_*</code>
 unid*= use <code>discrete_*</code>
 anova1= use <f>anova</f>
 nlinfit= use <f>leasqr</f>
 barttest= use <f>bartlett_test</f>
 ranksum= use <f>u_test</f>
 signrank= use <f>wilcoxon_test</f>
 signtest= use <f>sign_test</f>
 ttest= use <f>t_test</f>
 ttest2= use <f>t_test_2</f>
 ztest= use <f>z_test</f>

control >> Control theory
OCST demos
 DEMOcontrol
 controldemo
 sysrepdemo
 bddemo jet707 analdemo
 frdemo
 dgkfdemo hinfdemo dhinfdemo moddemo rldemo
System interface functions
 sysrepdemo
 fir2sys sys2fir
 ss2sys sys2ss
 tf2sys sys2tf
 zp2sys sys2zp
 tf2ss ss2tf
 zp2tf tf2zp
 zp2ss ss2zp zp
 ss
 tf
Data structure access
 syschtsam
 sysdimensions
 sysgetsignals
 sysgettsam
 sysgettype
 syssetsignals
 sysupdate
 minfo
System display functions
 sysout polyout tfout zpout
Block diagram manipulations
 bddemo jet707
 buildssic ord2 parallel sysadd sysmin
 sysappend sysconnect
 syscont sysdisc
 sysdup sysgroup sysmult sysprune
 sysreorder sysscale syssub ugain wgt1o
 starp
Numerical functions
 are dare dgram dlyap gram lyap pinv dre
 zgfmul zgfslv zginit zgreduce zgrownorm zgscal zgsgiv
 zgshsr
System properties
 analdemo
 abcddim ctrb h2norm hinfnorm obsv pzmap
 is_abcd is_controllable is_detectable is_dgkf
 is_digital is_observable is_sample is_siso is_stabilizable
 is_signal_list is_stable
Time domain analysis
 c2d d2c dmr2d damp dcgain impulse step
Frequency domain analysis
 frdemo
 bode bode_bounds nichols
 freqchkw ltifr nyquist tzero tzero2
 rlocus
Controller design
 dgkfdemo hinfdemo dhinfdemo
 dlqe dlqr lqe lqg lqr 
 hinf_ctr hinfsyn hinfsyn_ric hinfsyn_chk
 lsim place dkalman h2syn
Miscellaneous
 axis2dlim prompt sortcom swap run_cmd
 strappend listidx packedform sysidx
Obsolete
 dezero dlqg minfo packsys unpacksys swaprows swapcols rotg qzval
 syschnames series
Internal
 __bodquist__ __freqresp__ __stepimp__ __abcddims__ __syschnamesl__ 
 __syscont_disc__ __sysdefioname__ __sysdefstname__ __sysgroupn__
 __tf2sysl__ __zp2ssg2__ __outlist__ __zgpbal__
Compatibility
 filt= use <f>tf2sys</f>
 zpk= use <f>zp2sys</f>
 ssdata= use <f>sys2ss</f>
 tfdata=use <f>sys2tf</f>
 zpkdata=use <f>sys2zp</f>
 isct=use !<f>is_digital</f>
 isdt=use <f>is_digital</f>
 issiso=use <f>is_siso</f>
 append(sys)=use <f>sysappend</f>
 connect=use <f>sysconnect</f>
 lft=use <f>starp</f>
 norm(sys)=use <f>h2norm</f>, <f>hinfnorm</f> or <f>zgrownorm</f>
 zero=use <f>tzero</f> or <f>tzero2</f>
 kalman=use <f>lqe</f>
 kalmd=use <f>dlqe</f> or <f>dkalman</f>

image >> Image processing
Display
 image
 imagesc
 imshow
 image_viewer
Read/write
 loadimage saveimage
Colour controls
 hsv2rgb
 ntsc2rgb
 rgb2hsv
 rgb2ntsc
Representation
 gray2ind
 ind2gray
 ind2rgb
 rgb2ind
Colour maps
 gray
 ocean

signal >> Signal processing
Signals
 hurst
 periodogram
 sinc
 sinetone
 sinewave
 stft
 synthesis
Filtering
 fftfilt 
 spencer
 fractdiff
Filter analysis
 freqz freqz_plot
Filter conversion
 ss2tf 
 ss2zp 
 tf2ss 
 tf2zp 
 zp2ss 
 zp2tf 
IIR Filter design
 yulewalker
Power spectrum analysis
 spectral_adf spectral_xdf
Window functions
 bartlett 
 blackman 
 hamming 
 hanning
 rectangle_lw
 rectangle_sw
 triangle_lw
 triangle_sw
System identification
 durbinlevinson
 diffpara
 arch_rnd arch_fit arch_test
 arma_rnd autoreg_matrix autocor autocov

web >> Web Services
Read/write
 urlread urlwrite