Scilab 5.3.3
      
      
    Scilab 5.3.3 help
- Scilab
- Scilab keywords
- ans — answer
 - backslash — left matrix division.
 - brackets — ([,]) left and right brackets
 - case — keyword used in select
 - colon — (:) colon operator
 - comma — (,) column, instruction, argument separator
 - comments — comments
 - comparison — comparison, relational operators
 - do — language keyword for loops
 - dot — (.) symbol
 - else — keyword in if-then-else
 - elseif — keyword in if-then-else
 - empty — ([]) empty matrix
 - end — end keyword
 - equal — (=) assignment , comparison, equal sign
 - for — language keyword for loops
 - global — Define global variable
 - hat — (^) exponentiation
 - if — conditional execution
 - left — ([) left bracket
 - less — (<) greater than comparison
 - minus — (-) substraction operator, sign changes
 - not — (~) logical not
 - parents — ( ) left and right parenthesis
 - percent — (%) special character
 - plus — (+) addition operator
 - power — power operation (^,.^)
 - quote — (') transpose operator, string delimiter
 - return — return or resume execution and copy some local variables
 - select — select keyword
 - semicolon — ending expression and row separator
 - slash — (/) right division and feed back
 - star — (*) multiplication operator
 - then — keyword in if-then-else
 - tilda — (~) logical not
 - try — beginning of catch block in try-catch control instruction
 - while — while keyword
 
 - TMPDIR — temporary directory path
 - abort — interrupt evaluation.
 - add_demo — Add an entry in the demos list
 - argn — Returns the number of input/output arguments in a function call
 - banner — show scilab banner (Windows)
 - boolean — Scilab Objects, boolean variables and operators & | ~
 - break — keyword to interrupt loops
 - clear — kills variables
 - clearfun — remove primitive.
 - clearglobal — kills global variables
 - comp — scilab function compilation
 - continue — keyword to pass control to the next iteration of a loop
 - debug — debugging level
 - delbpt — delete breakpoints
 - dispbpt — display breakpoints
 - edit — function editing
 - errcatch — error trapping
 - errclear — error clearing
 - error — error messages
 - error_table — table of error messages
 - exists — checks variable existence
 - exit — Ends the current Scilab session
 - external — Scilab Object, external function or routine
 - extraction — matrix and list entry extraction
 - format — number printing and display format
 - funcprot — switch scilab functions protection mode
 - funptr — coding of primitives ( wizard stuff )
 - getdebuginfo — get information about Scilab to debug
 - getmd5 — get md5 checksum
 - getmemory — returns free and total system memory
 - getmodules — returns list of modules installed in Scilab
 - getos — return Operating System name and version
 - getscilabmode — returns scilab mode
 - getshell — returns current command interpreter.
 - getvariablesonstack — get variable names on stack of scilab
 - getversion — get scilab and modules version information
 - gstacksize — set/get scilab global stack size
 - ieee — set floating point exception mode
 - insertion — partial variable assignation
 - intppty — set interface argument passing properties
 - inv_coeff — build a polynomial matrix from its coefficients
 - iserror — error occurence test
 - isglobal — check if a variable is global
 - lasterror — get last recorded error message
 - macr2lst — function to list conversion
 - macr2tree — function to tree conversion
 - matrices — Scilab object, matrices in Scilab
 - matrix — reshape a vector or a matrix to a different size matrix
 - mode — select a mode in exec file
 - mtlb_mode — switch Matlab like operations
 - names — scilab names syntax
 - newfun — add a name in the table of functions
 - null — delete an element in a list
 - pause — pause mode, invoke keyboard
 - perl — Call Perl script using appropriate operating system executable
 - poly — polynomial definition
 - predef — variable protection
 - quit — Terminates Scilab or decreases the pause level
 - rational — Scilab objects, rational in Scilab
 - readgateway — get primitives list of a module
 - resume — return or resume execution and copy some local variables
 - sciargs — scilab command line arguments
 - scilab — Main script to start Scilab and miscellaneous tools (GNU/Linux, Unix and Mac OS X)
 - setbpt — set breakpoints
 - stacksize — set scilab stack size
 - startup — startup file
 - symbols — scilab operator names
 - testmatrix — generate special matrices, such as Hilbert, Franck
 - type — Returns the type of a variable
 - typename — associates a name to variable type
 - user — interfacing a Fortran or C routine
 - varn — symbolic variable of a polynomial
 - ver — Version information for Scilab
 - warning — warning messages
 - what — list the Scilab primitives
 - where — get current instruction calling tree
 - whereami — display current instruction calling tree
 - who — listing of variables
 - who_user — listing of user's variables
 - whos — listing of variables in long form
 - with_atlas — Checks if Scilab has been built with Atlas Library
 - with_javasci — Checks if Scilab has been built with the java interface
 - with_macros_source — Checks if macros source are installed
 - with_module — Checks if a Scilab module is installed
 - with_pvm — Checks if Scilab has been built with the "Parallel Virtual Machine" interface
 - with_texmacs — Checks if Scilab has been called by texmacs
 - with_tk — Checks if Scilab has been built with TCL/TK
 
 - Scilab keywords
 - Differential Equations, Integration
- bvode — Simplified call to bvode
 - dae — Differential algebraic equations solver
 - daeoptions — set options for dae solver
 - dasrt — DAE solver with zero crossing
 - dassl — differential algebraic equation
 - feval — multiple evaluation
 - impl — differential algebraic equation
 - int2d — definite 2D integral by quadrature and cubature method
 - int3d — definite 3D integral by quadrature and cubature method
 - intc — Cauchy integral
 - integrate — integration of an expression by quadrature
 - intg — definite integral
 - intl — Cauchy integral
 - ode — ordinary differential equation solver
 - ode_discrete — ordinary differential equation solver, discrete time simulation
 - ode_optional_output — ode solvers optional outputs description
 - ode_root — ordinary differential equation solver with root finding
 - odedc — discrete/continuous ode solver
 - odeoptions — set options for ode solvers
 
 - Elementary Functions
- Bitwise operations
 - Complex
 - Discrete mathematics
 - Elementary matrices
- diag — diagonal including or extracting
 - eye — identity matrix
 - ind2sub — linear index to matrix subscript values
 - linspace — linearly spaced vector
 - logspace — logarithmically spaced vector
 - meshgrid — create matrices or 3-D arrays
 - ndgrid — arrays for multidimensional function evaluation on grid
 - ones — matrix made of ones
 - rand — random number generator
 - sub2ind — matrix subscript values to linear index
 - zeros — matrix made of zeros
 
 - Floating point
- ceil — round up
 - double — conversion from integer to double precision representation
 - fix — round towards zero
 - floor — round down
 - frexp — dissect floating-point numbers into base 2 exponent and mantissa
 - int — round towards zero
 - isinf — check for infinite entries
 - isnan — check for "Not a Number" entries
 - nearfloat — get previous or next floating-point number
 - nextpow2 — next higher power of 2.
 - number_properties — determine floating-point parameters
 - round — round to nearest integer
 
 - Integer representation
 - Matrix manipulation
- flipdim — flip x components along a given dimension
 - permute — permute the dimensions of an array
 - repmat — Replicate and tile an array
 - resize_matrix — create a new matrix with a different size
 
 - Matrix operations
 - Search and sort
- dsearch — search in ordered sets
 - gsort — sorting by quick sort agorithm
 - lex_sort — lexicographic matrix rows sorting
 - vectorfind — finds in a matrix rows or columns matching a vector
 
 - Set operations
 - Signal processing
- bloc2exp — block-diagram to symbolic expression
 - bloc2ss — block-diagram to state-space conversion
 - pen2ea — pencil to E,A conversion
 - ssrand — random system generator
 - sysconv — system conversion
 - sysdiag — block diagonal system connection
 - syslin — linear system definition
 - trfmod — poles and zeros display
 
 - Symbolic
 - Trigonometry
- acos — element wise cosine inverse (radians)
 - acosd — element wise cosine inverse, result in degree.
 - acosh — hyperbolic cosine inverse
 - acoshm — matrix hyperbolic inverse cosine
 - acosm — matrix wise cosine inverse
 - acot — computes the element-wise inverse cotangeant of the argument.
 - acotd — computes the element-wise inverse cotangeant of the argument result in degree.
 - acoth — element wise hyperbolic cotangeant inverse.
 - acsc — computes the element-wise inverse cosecant of the argument.
 - acscd — computes the element-wise inverse cosecant of the argument, results in degree.
 - acsch — computes the element-wise inverse hyperbolic cosecant of the argument.
 - asec — computes the element-wise inverse secant of the argument.
 - asecd — computes the element-wise inverse secant of the argument, results in degree.
 - asech — computes the element-wise inverse hyperbolic secant of the argument.
 - asin — sine inverse (radians)
 - asind — sine inverse, results in degree
 - asinh — hyperbolic sine inverse
 - asinhm — matrix hyperbolic inverse sine
 - asinm — matrix wise sine inverse
 - atan — 2-quadrant and 4-quadrant inverse tangent
 - atand — 2-quadrant and 4-quadrant element-wise inverse tangent, result in degree.
 - atanh — hyperbolic tangent inverse
 - atanhm — matrix hyperbolic tangent inverse
 - atanm — square matrix tangent inverse
 - conj — conjugate
 - cos — cosine function
 - cosd — element-wise cosine function, argument in degree
 - cosh — hyperbolic cosine
 - coshm — matrix hyperbolic cosine
 - cosm — matrix cosine function
 - cotd — cotangent
 - cotg — cotangent
 - coth — hyperbolic cotangent
 - cothm — matrix hyperbolic cotangent
 - csc — Computes the element-wise cosecant of the argument.
 - cscd — Computes the element-wise cosecant of the argument given in degree.
 - csch — Computes the element-wise hyperbolic cosecant of the argument.
 - csgn — Returns the sign of a vector of real of complex values.
 - sec — Compute the element-wise secant of the argument.
 - secd — Compute the element-wise secant of the argument given in degree.
 - sech — Compute the element-wise hyperbolic secant of the argument.
 - sin — sine function
 - sinc — sinc function
 - sind — sine function, argument in degree.
 - sinh — hyperbolic sine
 - sinhm — matrix hyperbolic sine
 - sinm — matrix sine function
 - tan — tangent
 - tand — tangent, argument in degree.
 - tanh — hyperbolic tangent
 - tanhm — matrix hyperbolic tangent
 - tanm — matrix tangent
 
 - abs — absolute value, magnitude
 - amell — Jacobi's am function
 - and — logical and of the elements of an array
 - and_op — logical and operator
 - cat — concatenate several arrays
 - cell2mat — convert a cell array into a matrix
 - cellstr — convert strings vector (or strings matrix) into a cell of strings
 - char — char function
 - delip — complete and incomplete elliptic integral of first kind
 - diff — Difference and discrete derivative
 - exp — element-wise exponential
 - inttrap — integration of experimental data by trapezoidal interpolation
 - isdef — checks variable existence
 - isempty — check if a variable is an empty matrix or an empty list
 - isequal — objects comparison
 - isequalbitwise — bitwise comparison of variables
 - isvector — check if a variable is a vector
 - log — natural logarithm
 - log10 — logarithm
 - log1p — computes with accuracy the natural logarithm of its argument added by one
 - log2 — base 2 logarithm
 - logm — square matrix logarithm
 - lstsize — list, tlist, mlist numbers of entries
 - max — maximum
 - min — minimum
 - modulo — positive arithmetic remainder modulo m
 - ndims — number of dimensions of an array
 - norm — matrix norms
 - or — logical or of the elements of an array
 - or_op — logical or operator
 - pertrans — pertranspose
 - sign — sign function
 - signm — matrix sign function
 - size — size of objects
 - sqrt — square root
 - sqrtm — matrix square root
 - squarewave — generates a square wave with period 2*%pi
 - toeplitz — toeplitz matrix
 - typeof — object type
 
 - Linear Algebra
- aff2ab — linear (affine) function to A,b conversion
 - balanc — matrix or pencil balancing
 - bdiag — block diagonalization, generalized eigenvectors
 - chfact — sparse Cholesky factorization
 - chol — Cholesky factorization
 - chsolve — sparse Cholesky solver
 - classmarkov — recurrent and transient classes of Markov matrix
 - cmb_lin — symbolic linear combination
 - coff — resolvent (cofactor method)
 - colcomp — column compression, kernel, nullspace
 - companion — companion matrix
 - cond — condition number
 - det — determinant
 - eigenmarkov — normalized left and right Markov eigenvectors
 - ereduc — computes matrix column echelon form by qz transformations
 - expm — square matrix exponential
 - fstair — computes pencil column echelon form by qz transformations
 - fullrf — full rank factorization
 - fullrfk — full rank factorization of A^k
 - genmarkov — generates random markov matrix with recurrent and transient classes
 - givens — Givens transformation
 - glever — inverse of matrix pencil
 - gschur — generalized Schur form (obsolete).
 - gspec — eigenvalues of matrix pencil (obsolete)
 - hess — Hessenberg form
 - householder — Householder orthogonal reflexion matrix
 - im_inv — inverse image
 - inv — matrix inverse
 - kernel — kernel, nullspace
 - kroneck — Kronecker form of matrix pencil
 - linsolve — linear equation solver
 - lsq — linear least square problems.
 - lu — LU factorization with pivoting
 - lyap — Lyapunov equation
 - nlev — Leverrier's algorithm
 - orth — orthogonal basis
 - pbig — eigen-projection
 - pencan — canonical form of matrix pencil
 - penlaur — Laurent coefficients of matrix pencil
 - pinv — pseudoinverse
 - polar — polar form
 - proj — projection
 - projspec — spectral operators
 - psmall — spectral projection
 - qr — QR decomposition
 - quaskro — quasi-Kronecker form
 - randpencil — random pencil
 - range — range (span) of A^k
 - rank — rank
 - rankqr — rank revealing QR factorization
 - rcond — inverse condition number
 - rowcomp — row compression, range
 - rowshuff — shuffle algorithm
 - rref — computes matrix row echelon form by lu transformations
 - schur — [ordered] Schur decomposition of matrix and pencils
 - spaninter — subspace intersection
 - spanplus — sum of subspaces
 - spantwo — sum and intersection of subspaces
 - spec — eigenvalues of matrices and pencils
 - sqroot — W*W' hermitian factorization
 - squeeze — squeeze
 - sva — singular value approximation
 - svd — singular value decomposition
 - sylv — Sylvester equation.
 - trace — trace
 
 - Interpolation
- bsplin3val — 3d spline arbitrary derivative evaluation function
 - cshep2d — bidimensional cubic shepard (scattered) interpolation
 - eval_cshep2d — bidimensional cubic shepard interpolation evaluation
 - interp — cubic spline evaluation function
 - interp1 — one_dimension interpolation function
 - interp2d — bicubic spline (2d) evaluation function
 - interp3d — 3d spline evaluation function
 - interpln — linear interpolation
 - intsplin — integration of experimental data by spline interpolation
 - linear_interpn — n dimensional linear interpolation
 - lsq_splin — weighted least squares cubic spline fitting
 - smooth — smoothing by spline functions
 - splin — cubic spline interpolation
 - splin2d — bicubic spline gridded 2d interpolation
 - splin3d — spline gridded 3d interpolation
 
 - CACSD
- abcd — state-space matrices
 - abinv — AB invariant subspace
 - arhnk — Hankel norm approximant
 - arl2 — SISO model realization by L2 transfer approximation
 - arma — Scilab arma library
 - arma2p — extract polynomial matrices from ar representation
 - armac — Scilab description of an armax process
 - armax — armax identification
 - armax1 — armax identification
 - arsimul — armax simulation
 - augment — augmented plant
 - balreal — balanced realization
 - bilin — general bilinear transform
 - black — Black-Nichols diagram of a linear dynamical system
 - bode — Bode plot
 - bstap — hankel approximant
 - cainv — Dual of abinv
 - calfrq — frequency response discretization
 - canon — canonical controllable form
 - ccontrg — central H-infinity controller
 - chart — Nichols chart
 - cls2dls — bilinear transform
 - colinout — inner-outer factorization
 - colregul — removing poles and zeros at infinity
 - cont_frm — transfer to controllable state-space
 - cont_mat — controllability matrix
 - contr — controllability, controllable subspace, staircase
 - contrss — controllable part
 - copfac — right coprime factorization
 - csim — simulation (time response) of linear system
 - ctr_gram — controllability gramian
 - dbphi — frequency response to phase and magnitude representation
 - dcf — double coprime factorization
 - ddp — disturbance decoupling
 - des2ss — descriptor to state-space
 - des2tf — descriptor to transfer function conversion
 - dhinf — H_infinity design of discrete-time systems
 - dhnorm — discrete H-infinity norm
 - dscr — discretization of linear system
 - dsimul — state space discrete time simulation
 - dt_ility — detectability test
 - dtsi — stable anti-stable decomposition
 - equil — balancing of pair of symmetric matrices
 - equil1 — balancing (nonnegative) pair of matrices
 - evans — Evans root locus
 - feedback — feedback operation
 - findABCD — discrete-time system subspace identification
 - findAC — discrete-time system subspace identification
 - findBD — initial state and system matrices B and D of a discrete-time system
 - findBDK — Kalman gain and B D system matrices of a discrete-time system
 - findR — Preprocessor for estimating the matrices of a linear time-invariant dynamical system
 - findx0BD — Estimates state and B and D matrices of a discrete-time linear system
 - flts — time response (discrete time, sampled system)
 - fourplan — augmented plant to four plants
 - frep2tf — transfer function realization from frequency response
 - freq — frequency response
 - freson — peak frequencies
 - fspecg — stable factorization
 - fstabst — Youla's parametrization
 - g_margin — gain margin and associated crossover frequency
 - gainplot — magnitude plot
 - gamitg — H-infinity gamma iterations
 - gcare — control Riccati equation
 - gfare — filter Riccati equation
 - gfrancis — Francis equations for tracking
 - gtild — tilde operation
 - h2norm — H2 norm
 - h_cl — closed loop matrix
 - h_inf — H-infinity (central) controller
 - h_inf_st — static H_infinity problem
 - h_norm — H-infinity norm
 - hallchart — Draws the Hall chart
 - hankelsv — Hankel singular values
 - hinf — H_infinity design of continuous-time systems
 - imrep2ss — state-space realization of an impulse response
 - inistate — Estimates the initial state of a discrete-time system
 - invsyslin — system inversion
 - kpure — continuous SISO system limit feedback gain
 - krac2 — continuous SISO system limit feedback gain
 - lcf — normalized coprime factorization
 - leqr — H-infinity LQ gain (full state)
 - lft — linear fractional transformation
 - lin — linearization
 - linf — infinity norm
 - linfn — infinity norm
 - linmeq — Sylvester and Lyapunov equations solver
 - lqe — linear quadratic estimator (Kalman Filter)
 - lqg — LQG compensator
 - lqg2stan — LQG to standard problem
 - lqg_ltr — LQG with loop transform recovery
 - lqr — LQ compensator (full state)
 - ltitr — discrete time response (state space)
 - m_circle — plots the complex plane iso-gain contours of y/(1+y) (obsolete)
 - macglov — Mac Farlane Glover problem
 - markp2ss — Markov parameters to state-space
 - minreal — minimal balanced realization
 - minss — minimal realization
 - mucomp — mu (structured singular value) calculation
 - narsimul — armax simulation ( using rtitr)
 - nehari — Nehari approximant
 - nicholschart — Nichols chart
 - noisegen — noise generation
 - nyquist — nyquist plot
 - nyquistfrequencybounds — Computes the frequencies for which the nyquist locus enters and leaves a given rectangle.
 - obs_gram — observability gramian
 - obscont — observer based controller
 - observer — observer design
 - obsv_mat — observability matrix
 - obsvss — observable part
 - p_margin — phase margin and associated crossover frequency
 - parrot — Parrot's problem
 - pfss — partial fraction decomposition
 - phasemag — phase and magnitude computation
 - ppol — pole placement
 - prbs_a — pseudo random binary sequences generation
 - projsl — linear system projection
 - reglin — Linear regression
 - repfreq — frequency response
 - ric_desc — Riccati equation
 - ricc — Riccati equation
 - riccati — Riccati equation
 - routh_t — Routh's table
 - rowinout — inner-outer factorization
 - rowregul — removing poles and zeros at infinity
 - rtitr — discrete time response (transfer matrix)
 - sensi — sensitivity functions
 - sgrid — s-plane grid lines.
 - show_margins — display gain and phase margin and associated crossover frequencies
 - sident — discrete-time state-space realization and Kalman gain
 - sm2des — system matrix to descriptor
 - sm2ss — system matrix to state-space
 - sorder — computing the order of a discrete-time system
 - specfact — spectral factor
 - ss2des — (polynomial) state-space to descriptor form
 - ss2ss — state-space to state-space conversion, feedback, injection
 - ss2tf — conversion from state-space to transfer function
 - st_ility — stabilizability test
 - stabil — stabilization
 - svplot — singular-value sigma-plot
 - sysfact — system factorization
 - syssize — size of state-space system
 - tf2des — transfer function to descriptor
 - tf2ss — transfer to state-space
 - time_id — SISO least square identification
 - trzeros — transmission zeros and normal rank
 - ui_observer — unknown input observer
 - unobs — unobservable subspace
 - zeropen — zero pencil
 - zgrid — zgrid plot
 
 - Polynomials
- bezout — Bezout equation for polynomials or integers
 - clean — cleans matrices (round to zero small entries)
 - cmndred — common denominator form
 - coeff — coefficients of matrix polynomial
 - coffg — inverse of polynomial matrix
 - colcompr — column compression of polynomial matrix
 - degree — degree of polynomial matrix
 - denom — denominator
 - derivat — rational matrix derivative
 - determ — determinant of polynomial matrix
 - detr — polynomial determinant
 - diophant — diophantine (Bezout) equation
 - factors — numeric real factorization
 - gcd — gcd calculation
 - hermit — Hermite form
 - horner — polynomial/rational evaluation
 - hrmt — gcd of polynomials
 - htrianr — triangularization of polynomial matrix
 - invr — inversion of (rational) matrix
 - lcm — least common multiple
 - lcmdiag — least common multiple diagonal factorization
 - ldiv — polynomial matrix long division
 - numer — numerator
 - pdiv — polynomial division
 - pol2des — polynomial matrix to descriptor form
 - pol2str — polynomial to string conversion
 - polfact — minimal factors
 - residu — residue
 - roots — roots of polynomials
 - rowcompr — row compression of polynomial matrix
 - sfact — discrete time spectral factorization
 - simp — rational simplification
 - simp_mode — toggle rational simplification
 - sylm — Sylvester matrix
 - systmat — system matrix
 
 - Signal Processing
- How to
- DesignEllipticFilter — How to design an elliptic filter (analog and digital)
 
 - Signal — Signal manual description
 - analpf — create analog low-pass filter
 - bilt — bilinear or biquadratic transform SISO system given by a zero/poles representation
 - buttmag — Power transmission of a Butterworth filter
 - casc — cascade realization of filter from coefficients
 - cepstrum — cepstrum calculation
 - cheb1mag — response of Chebyshev type 1 filter
 - cheb2mag — response of type 2 Chebyshev filter
 - chepol — Chebychev polynomial
 - convol — convolution
 - corr — correlation, covariance
 - cspect — two sided cross-spectral estimate between 2 discrete time signals using the correlation method
 - czt — chirp z-transform algorithm
 - detrend — remove constant, linear or piecewise linear trend from a vector
 - dft — discrete Fourier transform
 - ell1mag — magnitude of elliptic filter
 - eqfir — minimax approximation of FIR filter
 - eqiir — Design of iir filters
 - faurre — filter computation by simple Faurre algorithm
 - ffilt — coefficients of FIR low-pass
 - fft — fast Fourier transform.
 - fft2 — two-dimension fast Fourier transform
 - fftshift — rearranges the fft output, moving the zero frequency to the center of the spectrum
 - filt_sinc — samples of sinc function
 - filter — filters a data sequence using a digital filter
 - find_freq — parameter compatibility for elliptic filter design
 - findm — for elliptic filter design
 - frfit — frequency response fit
 - frmag — magnitude of FIR and IIR filters
 - fsfirlin — design of FIR, linear phase filters, frequency sampling technique
 - group — group delay for digital filter
 - hank — covariance to hankel matrix
 - hilb — FIR approximation to a Hilbert transform filter
 - hilbert — Discrete-time analytic signal computation of a real signal using Hilbert transform
 - iir — iir digital filter
 - iirgroup — group delay Lp IIR filter optimization
 - iirlp — Lp IIR filter optimization
 - intdec — Changes sampling rate of a signal
 - jmat — row or column block permutation
 - kalm — Kalman update
 - lattn — recursive solution of normal equations
 - lattp — lattp
 - lev — Yule-Walker equations (Levinson's algorithm)
 - levin — Toeplitz system solver by Levinson algorithm (multidimensional)
 - lindquist — Lindquist's algorithm
 - mese — maximum entropy spectral estimation
 - mfft — multi-dimensional fft
 - mrfit — frequency response fit
 - percentasn — elliptic integral
 - percentk — Jacobi's complete elliptic integral
 - percentsn — Jacobi 's elliptic function
 - phc — Markovian representation
 - pspect — two sided cross-spectral estimate between 2 discrete time signals using the Welch's average periodogram method.
 - remez — Remez exchange algorithm for the weighted chebyshev approximation of a continuous function with a sum of cosines.
 - remezb — Minimax approximation of magnitude response
 - rpem — Recursive Prediction-Error Minimization estimation
 - sincd — digital sinc function or Direchlet kernel
 - srfaur — square-root algorithm
 - srkf — square root Kalman filter
 - sskf — steady-state Kalman filter
 - syredi — Design of iir filters, syredi code interface
 - system — observation update
 - trans — low-pass to other filter transform
 - wfir — linear-phase FIR filters
 - wiener — Wiener estimate
 - wigner — 'time-frequency' wigner spectrum
 - window — compute symmetric window of various type
 - yulewalk — least-square filter design
 - zpbutt — Butterworth analog filter
 - zpch1 — Chebyshev analog filter
 - zpch2 — Chebyshev analog filter
 - zpell — lowpass elliptic filter
 
 - How to
 - FFTW
- fftw — Fast fourier transform based on the fftw library
 - fftw_flags — set computation method of fast fourier transform of the fftw function
 - fftw_forget_wisdom — Reset fftw wisdom
 - get_fftw_wisdom — return fftw wisdom
 - set_fftw_wisdom — set fftw wisdom
 
 - Special Functions
- bessel — Bessel functions of the third kind (aka Hankel functions)
 - beta — beta function
 - calerf — computes error functions.
 - dlgamma — derivative of gammaln function, psi function
 - erf — The error function.
 - erfc — The complementary error function.
 - erfcx — scaled complementary error function.
 - erfinv — inverse error function
 - gamma — The gamma function.
 - gammaln — The logarithm of gamma function.
 - legendre — associated Legendre functions
 
 - Randlib
- grand — Random number generator(s)
 
 - ARnoldi PACKage
- dnaupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to a few eigenpairs of a real linear operator
 - dneupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute the converged approximations to eigenvalues of A*z = lambda*B*z approximations to a few eigenpairs of a real linear operator
 - dsaupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to a few eigenpairs of a real and symmetric linear operator
 - dseupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to the converged approximations to eigenvalues of A*z = lambda*B*z
 - znaupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute a few eigenpairs of a complex linear operator OP with respect to a semi-inner product defined by a hermitian positive semi-definite real matrix B.
 - zneupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to the converged approximations to eigenvalues of A*z = lambda*B*z
 
 - Statistics
- cdfbet — cumulative distribution function Beta distribution
 - cdfbin — cumulative distribution function Binomial distribution
 - cdfchi — cumulative distribution function chi-square distribution
 - cdfchn — cumulative distribution function non-central chi-square distribution
 - cdff — cumulative distribution function F distribution
 - cdffnc — cumulative distribution function non-central f-distribution
 - cdfgam — cumulative distribution function gamma distribution
 - cdfnbn — cumulative distribution function negative binomial distribution
 - cdfnor — cumulative distribution function normal distribution
 - cdfpoi — cumulative distribution function poisson distribution
 - cdft — cumulative distribution function Student's T distribution
 - center — center
 - wcenter — center and weight
 - cmoment — central moments of all orders
 - correl — correlation of two variables
 - covar — covariance of two variables
 - ftest — Fischer ratio
 - ftuneq — Fischer ratio for samples of unequal size.
 - geomean — geometric mean
 - harmean — harmonic mean
 - iqr — interquartile range
 - mad — mean absolute deviation
 - mean — mean (row mean, column mean) of vector/matrix entries
 - meanf — weighted mean of a vector or a matrix
 - median — median (row median, column median,...) of vector/matrix/array entries
 - moment — non central moments of all orders
 - msd — mean squared deviation
 - mvvacov — computes variance-covariance matrix
 - nancumsum — Thos function returns the cumulative sum of the values of a matrix
 - nand2mean — difference of the means of two independent samples
 - nanmax — max (ignoring Nan's)
 - nanmean — mean (ignoring Nan's)
 - nanmeanf — mean (ignoring Nan's) with a given frequency.
 - nanmedian — median of the values of a numerical vector or matrix
 - nanmin — min (ignoring Nan's)
 - nanstdev — standard deviation (ignoring the NANs).
 - nansum — Sum of values ignoring NAN's
 - nfreq — frequence of the values in a vector or matrix
 - pca — Computes principal components analysis with standardized variables
 - perctl — computation of percentils
 - princomp — Principal components analysis
 - quart — computation of quartiles
 - regress — regression coefficients of two variables
 - sample — Sampling with replacement
 - samplef — sample with replacement from a population and frequences of his values.
 - samwr — Sampling without replacement
 - show_pca — Visualization of principal components analysis results
 - st_deviation — standard deviation (row or column-wise) of vector/matrix entries
 - stdevf — standard deviation
 - strange — range
 - tabul — frequency of values of a matrix or vector
 - thrownan — Eliminates nan values
 - trimmean — trimmed mean of a vector or a matrix
 - variance — variance of the values of a vector or matrix
 - variancef — standard deviation of the values of a vector or matrix
 
 - Sparse Matrix
- adj2sp — converts adjacency form into sparse matrix.
 - full — sparse to full matrix conversion
 - gmres — Generalized Minimum RESidual method
 - issparse — determine whether input is sparse
 - ludel — utility function used with lufact
 - lufact — sparse lu factorization
 - luget — extraction of sparse LU factors
 - lusolve — sparse linear system solver
 - mtlb_sparse — convert sparse matrix
 - nnz — number of non zero entries in a matrix
 - pcg — precondioned conjugate gradient
 - qmr — quasi minimal resiqual method with preconditioning
 - sp2adj — converts sparse matrix into adjacency form
 - sparse — sparse matrix definition
 - spchol — sparse cholesky factorization
 - spcompack — converts a compressed adjacency representation
 - speye — sparse identity matrix
 - spget — retrieves entries of sparse matrix
 - spones — sparse matrix
 - sprand — sparse random matrix
 - spzeros — sparse zero matrix
 
 - UMFPACK Interface (sparse)
- PlotSparse — plot the pattern of non nul elements of a sparse matrix
 - ReadHBSparse — read a Harwell-Boeing sparse format file
 - cond2sp — computes an approximation of the 2-norm condition number of a s.p.d. sparse matrix
 - condestsp — estimate the condition number of a sparse matrix
 - rafiter — (obsolete) iterative refinement for a s.p.d. linear system
 - res_with_prec — computes the residual r = Ax-b with precision
 - taucs_chdel — utility function used with taucs_chfact
 - taucs_chfact — cholesky factorisation of a sparse s.p.d. matrix
 - taucs_chget — retrieve the Cholesky factorization at the scilab level
 - taucs_chinfo — get information on Cholesky factors
 - taucs_chsolve — solve a linear sparse (s.p.d.) system given the Cholesky factors
 - taucs_license — display the taucs license
 - umf_license — display the umfpack license
 - umf_ludel — utility function used with umf_lufact
 - umf_lufact — lu factorisation of a sparse matrix
 - umf_luget — retrieve lu factors at the scilab level
 - umf_luinfo — get information on LU factors
 - umf_lusolve — solve a linear sparse system given the LU factors
 - umfpack — solve sparse linear system
 
 - Optimization and Simulation
- Neldermead
- fminsearch — Computes the unconstrained minimimum of given function with the Nelder-Mead algorithm.
 - neldermead — Provides several direct search optimization algorithms based on the simplex method.
 - neldermead_overview — An overview of the Nelder-Mead toolbox.
 - nmplot — Provides several direct search optimization algorithms based on the simplex method.
 - optimget — Queries an optimization data structure.
 - optimplotfunccount — Plot the number of function evaluations of an optimization algorithm
 - optimplotfval — Plot the function value of an optimization algorithm
 - optimplotx — Plot the value of the parameters of an optimization algorithm
 - optimset — Configures and returns an optimization data structure.
 
 - Optimization base
- optimbase — Provides an abstract class for a general optimization component.
 
 - Optimization simplex
- optimsimplex — Manage a simplex with arbitrary number of points.
 
 - NDcost — generic external for optim computing gradient using finite differences
 - aplat — Flattens a list.
 - datafit — Parameter identification based on measured data
 - derivative — approximate derivatives of a function
 - fit_dat — Parameter identification based on measured data
 - fsolve — find a zero of a system of n nonlinear functions
 - karmarkar — Solves a linear optimization problem.
 - leastsq — Solves non-linear least squares problems
 - list2vec — Catenates list entries in a matrix.
 - lmisolver — linear matrix inequation solver
 - lmitool — tool for solving linear matrix inequations
 - lsqrsolve — minimize the sum of the squares of nonlinear functions, levenberg-marquardt algorithm
 - numdiff — numerical gradient estimation
 - optim — non-linear optimization routine
 - qld — linear quadratic programming solver
 - qp_solve — linear quadratic programming solver builtin
 - qpsolve — linear quadratic programming solver
 - quapro — linear quadratic programming solver (obsolete)
 - readmps — reads a file in MPS format
 - recons — reciprocal function for aplat.
 - semidef — semidefinite programming
 - vec2list — list2vec reciprocal function
 
 - Neldermead
 - Genetic Algorithms
- coding_ga_binary — A function which performs conversion between binary and continuous representation
 - coding_ga_identity — A "no-operation" conversion function
 - crossover_ga_binary — A crossover function for binary code
 - crossover_ga_default — A crossover function for continuous variable functions
 - init_ga_default — A function a initialize a population
 - mutation_ga_binary — A function which performs binary mutation
 - mutation_ga_default — A continuous variable mutation function
 - optim_ga — A flexible genetic algorithm
 - optim_moga — multi-objective genetic algorithm
 - optim_nsga — A multi-objective Niched Sharing Genetic Algorithm
 - optim_nsga2 — A multi-objective Niched Sharing Genetic Algorithm version 2
 - pareto_filter — A function which extracts non dominated solution from a set
 - selection_ga_elitist — An 'elitist' selection function
 - selection_ga_random — A function which performs a random selection of individuals
 
 - Simulated Annealing
- accept_func_default — The default Simulated Annealing acceptation function.
 - accept_func_vfsa — The Very Fast Simulated Annealing acceptation function.
 - compute_initial_temp — A SA function which allows to compute the initial temperature of the simulated annealing
 - neigh_func_csa — The classical neighborhood relationship for the simulated annealing
 - neigh_func_default — A SA function which computes a neighbor of a given point
 - neigh_func_fsa — The Fast Simulated Annealing neghborhood relationship
 - neigh_func_vfsa — The Very Fast Simulated Annealing neighborhood relationship
 - optim_sa — A Simulated Annealing optimization method
 - temp_law_csa — The classical temperature decrease law
 - temp_law_default — A SA function which computed the temperature of the next temperature stage
 - temp_law_fsa — The Szu and Hartley Fast simulated annealing
 - temp_law_huang — The Huang temperature decrease law for the simulated annealing
 - temp_law_vfsa — This function implements the Very Fast Simulated Annealing from L. Ingber
 
 - Symbolic
 - Files : Input/Output functions
- basename — strip directory and suffix from filenames
 - chdir — changes Scilab current directory
 - copyfile — Copy file
 - createdir — Make new directory
 - deletefile — delete a file
 - dir — get file list
 - dirname — get directory from filenames
 - dispfiles — display opened files properties
 - fileext — returns extension for a file path
 - fileinfo — Provides information about a file
 - fileparts — returns the path, filename and extension for a file path
 - filesep — returns directory separator for current platform
 - findfiles — Finding all files with a given filespec
 - fprintf — Emulator of C language fprintf function
 - fprintfMat — Write a matrix in a file.
 - fscanf — Converts formatted input read on a file
 - fscanfMat — Reads a Matrix from a text file.
 - fullfile — Build a full filename from parts
 - fullpath — Creates an full path name for the specified relative path name.
 - get_absolute_file_path — Given an absolute pathname of a file opened in scilab.
 - getdrives — Get the drive letters of all mounted filesystems on the computer.
 - getlongpathname — get long path name (Only for Windows)
 - getrelativefilename — Given an absolute directory and an absolute filename, returns a relative file name.
 - getshortpathname — get short path name (Only for Windows)
 - percentio — variable returns standard input and standard output (file descriptor).
 - isdir — checks if argument is a directory path
 - isfile — checks if argument is a file
 - listfiles — list files
 - listvarinfile — list the contents of a saved data file
 - ls — show files
 - maxfiles — sets the limit for the number of files a scilab is allowed to have open simultaneously.
 - mclearerr — reset binary file access errors
 - mclose — close an opened file
 - mdelete — Delete file(s)
 - meof — check if end of file has been reached
 - merror — tests the file access errors indicator
 - mfprintf — converts, formats, and writes data to a file
 - mfscanf — reads its input from the character string (interface to the C sscanf function)
 - mget — reads byte or word in a given binary format return an int type
 - mgetl — read lines from an text file
 - mgetstr — read a character string from a file
 - mkdir — Make new directory
 - mopen — open a file
 - movefile — Move file or directory
 - mput — writes byte or word in a given binary format
 - mputl — writes strings in an ascii file
 - mputstr — write a character string in a file
 - mseek — set current position in binary file.
 - mtell — binary file management
 - newest — returns newest file of a set of files
 - pathconvert — pathnames convertion between POSIX and windows.
 - pathsep — returns path separator for current platform
 - pwd — get Scilab current directory
 - removedir — Remove a directory
 - rmdir — Remove a directory
 - save_format — format of files produced by "save"
 - scanf — Converts formatted input on standard input
 - scanf_conversion — scanf, sscanf, fscanf conversion specifications
 - sscanf — Converts formatted input given by a string
 
 - Input/Output functions
- file — file management
 - getenv — get the value of an environment variable
 - getio — get Scilab input/output logical units
 - getpid — get Scilab process identificator
 - getscilabkeywords — returns a list with all scilab keywords.
 - halt — stop execution
 - host — Unix or DOS command execution
 - input — prompt for user input
 - load — Load a saved variable or a serie of variables
 - oldload — load saved variable in 2.4.1 and previous formats (OBSOLETE)
 - oldsave — saving variables in 2.4.1 and previous format (OBSOLETE)
 - read — matrices read
 - read4b — fortran file binary read
 - readb — fortran file binary read
 - save — Save a variable or a serie of variables in a binary file
 - setenv — set the value of an environment variable
 - unix — shell (sh) command execution
 - unix_g — shell (sh) command execution, output redirected to a variable
 - unix_s — shell (sh) command execution, no output
 - unix_w — shell (sh) command execution, output redirected to scilab window
 - unix_x — shell (sh) command execution, output redirected to a window
 - writb — fortran file binary write
 - write — write in a formatted file
 - write4b — fortran file binary write
 
 - Graphics
- 2d_plot
- LineSpec — to quickly customize the lines appearance in a plot
 - Matplot — 2D plot of a matrix using colors
 - Matplot1 — 2D plot of a matrix using colors
 - Matplot_properties — description of the Matplot entities properties
 - Sfgrayplot — smooth 2D plot of a surface defined by a function using colors
 - Sgrayplot — smooth 2D plot of a surface using colors
 - champ — 2D vector field plot
 - champ1 — 2D vector field plot with colored arrows
 - champ_properties — description of the 2D vector field entity properties
 - comet — 2D comet animated plot.
 - contour2d — level curves of a surface on a 2D plot
 - contour2di — compute level curves of a surface on a 2D plot
 - contourf — filled level curves of a surface on a 2D plot
 - errbar — add vertical error bars on a 2D plot
 - fchamp — direction field of a 2D first order ODE
 - fcontour2d — level curves of a surface defined by a function on a 2D plot
 - fec — pseudo-color plot of a function defined on a triangular mesh
 - fec_properties — description of the fec entities properties
 - fgrayplot — 2D plot of a surface defined by a function using colors
 - fplot2d — 2D plot of a curve defined by a function
 - grayplot — 2D plot of a surface using colors
 - grayplot_properties — description of the grayplot entities properties
 - graypolarplot — Polar 2D plot of a surface using colors
 - histplot — plot a histogram
 - oldplot — simple plot (old version)
 - paramfplot2d — animated plot of a 2D parametrized curve.
 - plot — 2D plot
 - plot2d — 2D plot
 - plot2d1 — 2D plot (logarithmic axes) (obsolete)
 - plot2d2 — 2D plot (step function)
 - plot2d3 — 2D plot (vertical bars)
 - plot2d4 — 2D plot (arrows style)
 - plot2d_old_version — The syntaxes described below are obsolete
 - polarplot — Plot polar coordinates
 
 - 3d_plot
- comet3d — 3D comet animated plot.
 - contour — level curves on a 3D surface
 - eval3d — values of a function on a grid
 - eval3dp — compute facets of a 3D parametric surface
 - fac3d — 3D plot of a surface (obsolete)
 - fcontour — level curves on a 3D surface defined by a function
 - fplot3d — 3D plot of a surface defined by a function
 - fplot3d1 — 3D gray or color level plot of a surface defined by a function
 - genfac3d — compute facets of a 3D surface
 - geom3d — projection from 3D on 2D after a 3D plot
 - hist3d — 3D representation of a histogram
 - mesh — 3D mesh plot
 - milk_drop — milk drop 3D function
 - nf3d — rectangular facets to plot3d parameters
 - param3d — 3D plot of a parametric curve
 - param3d1 — 3D plot of parametric curves
 - param3d_properties — description of the 3D curves entities properties
 - plot3d — 3D plot of a surface
 - plot3d1 — 3D gray or color level plot of a surface
 - plot3d2 — plot surface defined by rectangular facets
 - plot3d3 — mesh plot surface defined by rectangular facets
 - secto3d — 3D surfaces conversion
 - surf — 3D surface plot
 - surface_properties — description of the 3D entities properties
 
 - annotation
- captions — draw graph captions
 - label_properties — description of the Label entity properties
 - legend — draw graph legend
 - legend_properties — description of the Legend entity properties.
 - legends — draw graph legend
 - title — display a title on a graphic window
 - xlabel — label z-axis
 - xtitle — add titles on a graphics window
 
 - axes_operations
- axes_properties — description of the axes entity properties
 - gca — Return handle of current axes.
 - gda — Return handle of default axes.
 - graduate — pretty axis graduations
 - isoview — set scales for isometric plot (do not change the size of the window)
 - newaxes — Creates a new Axes entity
 - plotframe — plot a frame with scaling and grids. This function is obsolete.
 - replot — redraw the current graphics window with new boundaries
 - rotate_axes — Interactive rotation of an Axes handle.
 - sca — set the current axes entity
 - sda — Set default axes.
 - subplot — divide a graphics window into a matrix of sub-windows
 - unzoom — unzoom graphics
 - zoom_rect — zoom a selection of the current graphic figure
 
 - axis
- axis_properties — description of the axis entity properties
 - drawaxis — draw an axis
 
 - bar_histogram
- bar — bar histogram
 - barh — horizontal display of bar histogram
 - barhomogenize — homogenize all the bars included in the current working axes
 
 - Color management
- addcolor — add new colors to the current colormap
 - autumncolormap — red through orange to yellow colormap
 - bonecolormap — gray colormap with a light blue tone
 - color — returns the color id of a color
 - color_list — list of named colors
 - colorbar — draw a colorbar
 - colordef — Set default color values to display different color schemes
 - colormap — using colormaps
 - coolcolormap — cyan to magenta colormap
 - coppercolormap — black to a light copper tone colormap
 - getcolor — opens a dialog to show colors in the current colormap
 - graycolormap — linear gray colormap
 - hotcolormap — red to yellow colormap
 - hsv2rgb — Converts HSV colors to RGB
 - hsvcolormap — Hue-saturation-value colormap
 - jetcolormap — blue to red colormap
 - name2rgb — returns the RGB values of a named color
 - oceancolormap — linear blue colormap
 - pinkcolormap — sepia tone colorization on black and white images
 - rainbowcolormap — red through orange, yellow, green,blue to violet colormap
 - rgb2name — returns the name of a color
 - springcolormap — magenta to yellow colormap
 - summercolormap — green to yellow colormap
 - whitecolormap — completely white colormap
 - wintercolormap — blue to green colormap
 
 - Datatips
- datatipCreate — Create a data tip on a polyline by program
 - datatipGetEntities — Get all the entities compatible with datatips in the given axes.
 - datatipGetStruct — Extract the datatips data structure infrom the curve or surface entity.
 - datatipInitStruct — initialize the datatip structure associated with the given polyline.
 - datatipManagerMode — Set or toggles the data tips mode.
 - datatipMove — Move a specified datatip using the mouse.
 - datatipRedraw — Adjust datatip text boxes positions after a 3D rotation
 - datatipRemove — Removes a selected datatip
 - datatipRemoveAll — Removes all datatips on a set of polylines.
 - datatipSetDisplay — Search the nearest datatip of a given point.
 - datatipSetInterp — Set the interpolation mode for tip location.
 - datatipSetOrientation — Search the nearest datatip of a given point.
 - datatipSetStruct — Stores the datatips data structure in the curve or surface entity.
 - datatipToggle — toggles the data tips mode.
 - datatips — Tool for placing and editing tips along the plotted curves.
 - orthProj — Computes the orthogonal projection of a point to a polyline in the plane.
 
 - figure_operations
- clf — clear or reset the current graphic figure (window) to default values
 - drawlater — makes axes children invisible.
 - drawnow — draw hidden graphics entities.
 - figure_properties — description of the graphics figure entity properties
 - gcf — Return handle of current graphic window.
 - gdf — Return handle of default figure.
 - scf — set the current graphic figure (window)
 - sdf — Set default figure.
 
 - geometric_shapes
- arc_properties — description of the Arc entity properties
 - rectangle_properties — description of the Rectangle entity properties
 - xarc — draw a part of an ellipse
 - xarcs — draw parts of a set of ellipses
 - xarrows — draw a set of arrows
 - xfarc — fill a part of an ellipse
 - xfarcs — fill parts of a set of ellipses
 - xfrect — fill a rectangle
 - xrect — draw a rectangle
 - xrects — draw or fill a set of rectangles
 
 - handle
- copy — copy a graphics entity.
 - delete — delete a graphic entity and its children.
 - draw — draw an entity.
 - gce — Get current entity handle.
 - ged — Scilab Graphic Editor
 - get_figure_handle — get a figure handle from its id
 - glue — glue a set of graphics entities into an Compound.
 - is_handle_valid — Check wether a set of graphic handles is still valid.
 - relocate_handle — Move handles inside the graphic hierarchy.
 - sd2sci — gr_menu structure to scilab instruction convertor
 - swap_handles — Permute two handles in the graphic Hierarchy.
 - unglue — unglue a coumpound object and replace it by individual children.
 
 - interaction
- dragrect — Drag rectangle(s) with mouse
 - edit_curv — interactive graphic curve editor
 - eventhandlerfunctions — Prototype of functions which may be used as event handler.
 - locate — mouse selection of a set of points
 - seteventhandler — set an event handler for the current graphic window
 - xclick — Wait for a mouse click.
 - xgetmouse — get the mouse events and current position
 
 - load_save
 - pie
- pie — draw a pie
 
 - polygon
 - property
 - style
- getlinestyle — dialog to select linestyle. Obsolete function.
 - getmark — dialog to select mark (symbol). Obsolete function
 - getsymbol — dialog to select a symbol and its size. Obsolete function
 
 - text
- getfont — dialog to select font . Obsolete function.
 - graphics_fonts — description of fonts used in graphic figures
 - math_rendering_features_in_graphic — Display mathematical equations in Scilab graphics through the LaTeX or MathML languages.
 - stringbox — Compute the bounding rectangle of a text or a label.
 - text_properties — description of the Text entity properties
 - titlepage — add a title in the middle of a graphics window
 - xinfo — draw an info string in the message subwindow
 - xlfont — load a font in the graphic context or query loaded font
 - xstring — draw strings
 - xstringb — draw strings into a box
 - xstringl — compute a box which surrounds strings
 
 - transform
 - window_control
- havewindow — return scilab window mode
 - show_window — raises a graphics window
 - winsid — return the list of graphics windows
 - xselect — raise the current graphics window
 
 - GlobalProperty — to customize the objects appearance (curves, surfaces...) in a plot or surf command.
 - Graphics — graphics library overview
 - alufunctions — pixel drawing functions. This function is obsolete.
 - clear_pixmap — erase the pixmap buffer
 - Compound_properties — description of the Compound entity properties
 - graphics_entities — description of the graphics entities data structures
 - object_editor — description of the graphic object editor capacities
 - pixel_drawing_mode — bitwise pixel rendering functions.
 - plzr — pole-zero plot
 - rubberbox — Rubberband box for rectangle selection
 - segs_properties — description of the Segments entity properties
 - show_pixmap — send the pixmap buffer to the screen
 - square — set scales for isometric plot (change the size of the window)
 - twinkle — is used to have a graphics entity twinkle
 - xbasr — redraw a graphics window
 - xchange — transform real to pixel coordinates
 - xclear — clears a graphics window
 - xdel — delete a graphics window
 - xget — get current values of the graphics context. This function is obsolete.
 - xgetech — get the current graphics scale
 - xgraduate — axis graduation
 - xgrid — add a grid on a 2D plot
 - xname — change the name of the current graphics window
 - xnumb — draw numbers
 - xpause — suspend Scilab
 - xsegs — draw unconnected segments
 - xset — set values of the graphics context. This function is obsolete.
 - xsetech — set the sub-window of a graphics window for plotting
 - xsetm — dialog to set values of the graphics context. Obsolete function.
 
 - 2d_plot
 - Graphics : exporting and printing
- driver — select a graphics driver
 - xend — close a graphics session
 - xinit — Initialization of a graphics driver
 - xs2bmp — Export graphics to BMP.
 - xs2emf — Export graphics to EMF (Only under Windows).
 - xs2eps — Export graphics to EPS.
 - xs2fig — Export graphics to FIG.
 - xs2gif — Export graphics to GIF.
 - xs2jpg — Export graphics to JPG.
 - xs2pdf — Export graphics to PDF.
 - xs2png — Export graphics to PNG.
 - xs2ppm — Export graphics to PPM.
 - xs2ps — Export graphics to PS.
 - xs2svg — Export graphics to SVG.
 
 - GUI
- Tree
- uiConcatTree — Concatenation of Trees
 - uiCreateNode — Creation of node (for Scilab Tree)
 - uiCreateTree — Creation of a Tree
 - uiDeleteNode — Deletion in a Tree
 - uiDisplayTree — Printing a Tree in GUI mode
 - uiDumpTree — Printing a Tree in the console (text mode)
 - uiEqualsTree — Comparing two trees
 - uiFindNode — Find node in Tree
 - uiGetChildrenNode — Get Children of a node
 - uiGetNodePosition — Get the position(s) of a node
 - uiGetParentNode — Get Parent of a node
 - uiInsertNode — Insertion in a Tree
 
 - about — show "about scilab" dialog box
 - addmenu — interactive button or menu definition
 - clipboard — Copy and paste strings to and from the system clipboard.
 - close — close a figure
 - delmenu — interactive button or menu deletion
 - exportUI — Call the file export graphical interface
 - figure — create a figure
 - findobj — find an object with specified property
 - gcbo — Handle of the object whose callback is executing.
 - getcallbackobject — Return the handle of the object whose callback is executing.
 - getinstalledlookandfeels — returns a string matrix with all Look and Feels.
 - getlookandfeel — gets the current default look and feel.
 - getvalue — xwindow dialog for data acquisition
 - messagebox — Open a message box.
 - printfigure — Opens a printing dialog and prints a figure.
 - printsetupbox — Display print dialog box.
 - progressionbar — Draw a progression bar
 - root_properties — description of the root object properties.
 - setlookandfeel — sets the current default look and feel.
 - setmenu — interactive button or menu activation
 - toolbar — show or hide a toolbar
 - toprint — Send text or figure to the printer.
 - uicontrol — create a Graphic User Interface object
 - uigetcolor — Opens a dialog for selecting a color.
 - uigetdir — dialog for selecting a directory
 - uigetfile — dialog window to get a file(s) name(s), path and filter index
 - uigetfont — Opens a dialog for selecting a font.
 - uimenu — Create a menu or a submenu in a figure
 - uiputfile — Open standard dialog box for selecting and saving file.
 - unsetmenu — interactive button or menu or submenu de-activation
 - usecanvas — Get/Set the main component used for Scilab graphics.
 - waitbar — Draw a waitbar
 - x_choices — interactive Xwindow choices through toggle buttons
 - x_choose — interactive window choice (modal dialog)
 - x_choose_modeless — interactive window choice (not modal dialog)
 - x_dialog — Dialog for interactive multi-lines input.
 - x_matrix — Xwindow editing of matrix
 - x_mdialog — Dialog for interactive vector/matrix input.
 
 - Tree
 - Data Structures
- cell — Create a cell array of empty matrices.
 - definedfields — return index of list's defined fields
 - fieldnames — get a tlist, mlist or struct fields names
 - getfield — list field extraction
 - hypermat — initialize an N dimensional matrices
 - hypermatrices — Scilab object, N dimensional matrices in Scilab
 - iscell — Check if a variable is a cell array
 - iscellstr — Check if a variable is a cell array of strings
 - isfield — Checks if the given fieldname exists in the structure
 - isstruct — Check if a variable is a structure array
 - list — Scilab object and list function definition
 - lsslist — Scilab linear state space function definition
 - lstcat — list concatenation
 - mlist — Scilab object, matrix oriented typed list definition.
 - rlist — Scilab rational fraction function definition
 - setfield — list field insertion
 - struct — create a struct
 - tlist — Scilab object and typed list definition.
 
 - Parameters
- add_param — Add a parameter to a list of parameters
 - get_param — Get the value of a parameter in a parameter list
 - init_param — Initialize the structure which will handles the parameters list
 - is_param — Check if a parameter is present in a parameter list
 - list_param — List all the parameters name in a list of parameters
 - remove_param — Remove a parameter and its associated value from a list of parameters
 - set_param — Set the value of a parameter in a parameter list
 
 - Boolean
 - Integers
 - Strings
- ascii — string ascii conversions
 - blanks — Create string of blank characters
 - code2str — returns character string associated with Scilab integer codes.
 - convstr — case conversion
 - emptystr — zero length string
 - eval — evaluation of a matrix of strings
 - evstr — evaluation of expressions
 - grep — find matches of a string in a vector of strings
 - isalphanum — check that characters of a string are alphanumerics
 - isascii — tests if character is a 7-bit US-ASCII character
 - isdigit — check that characters of a string are digits between 0 and 9
 - isletter — check that characters of a string are alphabetics letters
 - isnum — tests if a string represents a number
 - justify — Justify character array.
 - length — length of object
 - part — extraction of strings
 - regexp — find a substring that matches the regular expression string
 - sci2exp — converts an expression to a string
 - str2code — return scilab integer codes associated with a character string
 - strcat — concatenate character strings
 - strchr — Find the first occurrence of a character in a string
 - strcmp — compare character strings
 - strcmpi — compare character strings (case independent)
 - strcspn — Get span until character in string
 - strindex — search position of a character string in an other string.
 - string — conversion to string
 - strings — Scilab Object, character strings
 - stripblanks — Strips / trims leading and trailing blanks (and tabs) of strings
 - strncpy — Copy characters from strings
 - strrchr — Find the last occurrence of a character in a string
 - strrev — returns string reversed
 - strsplit — split a string into a vector of strings
 - strspn — Get span of character set in string
 - strstr — Locate substring
 - strsubst — substitute a character string by another in a character string.
 - strtod — Convert string to double.
 - strtok — Split string into tokens
 - tokenpos — returns the tokens positions in a character string.
 - tokens — returns the tokens of a character string.
 - tree2code — generates ascii definition of a Scilab function
 
 - Sound file handling
- analyze — frequency plot of a sound signal
 - auread — load .au sound file
 - auwrite — writes .au sound file
 - beep — Produce a beep sound
 - lin2mu — linear signal to mu-law encoding
 - loadwave — load a sound wav file into scilab
 - mapsound — Plots a sound map
 - mu2lin — mu-law encoding to linear signal
 - playsnd — sound player facility
 - savewave — save data into a sound wav file.
 - sound — sound player facility
 - soundsec — generates n sampled seconds of time parameter
 - wavread — load .wav sound file
 - wavwrite — writes .wav sound file
 
 - Time and Date
- calendar — Calendar
 - clock — Return current time as date vector
 - date — Current date as date string
 - datenum — Convert to serial date number
 - datevec — Date components
 - eomday — Return last day of month
 - etime — Elapsed time
 - getdate — get date and time information
 - now — Return current date and time
 - realtime — set dates origin or waits until date
 - sleep — suspend Scilab
 - tic — start a stopwatch timer
 - timer — cpu time
 - toc — Read the stopwatch timer
 - weekday — Return day of week
 
 - Output functions
- diary — diary of session
 - disp — displays variables
 - mprintf — converts, formats, and writes data to the main scilab window
 - msprintf — converts, formats, and writes data in a string
 - prettyprint — From any Scilab datatype and provide a representation to the TeX, LaTeX or MathML formats
 - print — prints variables in a file
 - printf — Emulator of C language printf function
 - printf_conversion — printf, sprintf, fprintf conversion specifications
 - sprintf — Emulator of C language sprintf function
 - ssprint — pretty print for linear system
 
 - Xcos
- Batch functions
- lincos — Constructs by linearization a linear state-space model from a general dynamical system described by a xcos diagram
 - scicos — OBSOLETE - see xcos
 - scicos_simulate — Function for running xcos simulation in batch mode
 - scicosim — xcos (batch) simulation function
 - steadycos — Finds an equilibrium state of a general dynamical system described by a xcos diagram
 
 - palettes
- Annotations palette
- Annotations_pal — Annotations palette
 - TEXT_f — Free annotation
 
 - Commonly used blocks palette
- Commonlyusedblocks_pal — Commonly used blocks palette
 - LOGICAL_OP — Logical operation
 - RELATIONALOP — Relational operation
 
 - Continuous time systems palette
- Continuous_pal — Continuous time systems palette
 - CLINDUMMY_f — Dummy
 - CLR — Continuous transfer function
 - CLSS — Continuous state-space system
 - DERIV — Derivative
 - INTEGRAL_f — Integration
 - INTEGRAL_m — Integration
 - PID — PID regulator
 - TCLSS — Continuous linear system with jump
 - TIME_DELAY — Time delay
 - VARIABLE_DELAY — Variable delay
 
 - Demonstrations blocks palette
 - Discontinuities palette
- discontinuities_pal — discontinuities palette
 - BACKLASH — Backlash
 - DEADBAND — Deadband
 - HYSTHERESIS — Hystheresis
 - RATELIMITER — Rate limiter
 - SATURATION — Saturation
 
 - Discrete time systems palette
- Discrete_pal — Discrete time systems palette
 - DELAYV_f — Variable delay
 - DELAY_f — Discrete time delay
 - DLR — Discrete transfer function
 - DLRADAPT_f — Discrete Zero-Pole
 - DLSS — Discrete state-space system
 - DOLLAR_f — Delay operator
 - REGISTER — Shift Register
 
 - Electrical palette
- Electrical_pal — Electrical palette
 - CCS — Controllable Modelica current source
 - CVS — Controllable Modelica voltage source
 - Capacitor — Electrical capacitor
 - ConstantVoltage — Electrical DC voltage source
 - CurrentSensor — Electrical current sensor
 - Diode — Electrical diode
 - Ground — Ground (zero potential reference)
 - Gyrator — Modelica Gyrator
 - IdealTransformer — Ideal Transformer
 - Inductor — Electrical inductor
 - NMOS — Simple NMOS Transistor
 - NPN — NPN transistor
 - OpAmp — Ideal opamp (norator-nullator pair)
 - PMOS — Simple PMOS Transistor
 - PNP — PNP transistor
 - PotentialSensor — Potential sensor
 - Resistor — Electrical resistor
 - SineVoltage — Sine voltage source
 - Switch — Non-ideal electrical switch
 - VVsourceAC — Variable AC voltage source
 - VariableResistor — Electrical variable resistor
 - VoltageSensor — Electrical voltage sensor
 - VsourceAC — Electrical AC voltage source
 
 - Event handling palette
- Events_pal — Event handling palette
 - ANDBLK — Activation and
 - ANDLOG_f — Logical and
 - CEVENTSCOPE — Activation scope
 - CLKFROM — Receives data from a corresponding CLKGOTO
 - CLKGOTO — Pass block input to CLKFROM block
 - CLKGotoTagVisibility — Define Scope of CLKGOTO tag visibility
 - CLKSOMV_f — Activation union
 - EDGE_TRIGGER — EDGE_TRIGGER block
 - ESELECT_f — Synchronous block Event-Select
 - EVTDLY_c — Event delay
 - EVTGEN_f — Event generator
 - EVTVARDLY — Event variable delay
 - Extract_Activation — Extract_Activation block
 - HALT_f — Halt
 - IFTHEL_f — Synchronous block If-Then-Else
 - MCLOCK_f — MCLOCK_f title
 - MFCLCK_f — MFCLCK_f title
 - M_freq — Multiple Frequencies
 - freq_div — Frequency division
 
 - Implicit palette
- Implicit_pal — Implicit palette
 - CONSTRAINT_c — Constraint
 - DIFF_f — Derivative
 
 - Integer palette
- Integer_pal — Integer palette
 - BITCLEAR — Clear a Bit
 - BITSET — Set a Bit
 - CONVERT — Data Type Conversion
 - DFLIPFLOP — D flip-flop
 - DLATCH — D latch flip-flop
 - EXTRACTBITS — Bits Extraction
 - INTMUL — Integer matrix multiplication
 - JKFLIPFLOP — JK flip-flop
 - LOGIC — Combinatorial Logic
 - SHIFT — Shift/Rotates Bits
 - SRFLIPFLOP — SR flip-flop
 
 - Lookup tables palette
- Lookuptables_pal — Lookup tables palette
 - INTRP2BLK_f — 2D interpolation
 - INTRPLBLK_f — Interpolation
 - LOOKUP_f — Lookup table
 
 - Math operations palette
- Mathoperations_pal — Math operations palette
 - ABS_VALUE — Absolute value
 - BIGSOM_f — Scalar or vector Addition/Soustraction
 - COSBLK_f — Cosine
 - EXPBLK_m — Exponential of a scalar
 - GAINBLK_f — Gain
 - INVBLK — Inverse
 - LOGBLK_f — Logarithm
 - MATMAGPHI — Complex from/to Magnitude and Angle Conversion
 - MATZREIM — Complex decomposition/composition
 - MAXMIN — Maximum or minimum value of vectors's elements
 - MAX_f — Maximum value of a vector's elements
 - MIN_f — Minimum value of a vector's elements
 - POWBLK_f — Array power
 - PRODUCT — Element-wise vector multiplication/division
 - PROD_f — Element-wise product
 - SIGNUM — Sign
 - SINBLK_f — Sine
 - SQRT — Square root
 - SUMMATION — Matrix Addition/Subtraction
 - SUM_f — Addition
 - TANBLK_f — Tangent
 - TrigFun — Trigonometric function
 
 - Matrix operation palette
- Matrix_pal — Matrix operation palette
 - CUMSUM — Cumulative Sum
 - EXTRACT — Matrix extractor
 - EXTTRI — Triangular or Diagonal Extraction
 - MATBKSL — Left matrix division
 - MATCATH — Horizontal Concatenation
 - MATCATV — Vertical Concatenation
 - MATDET — Matrix Determinant
 - MATDIAG — Create Diagonal Matrix
 - MATDIV — Matrix division
 - MATEIG — Matrix Eigenvalues
 - MATEXPM — Matrix Exponential
 - MATINV — Matrix Inverse
 - MATLU — LU Factorization
 - MATMUL — Matrix Multiplication
 - MATPINV — Matrix PseudoInverse
 - MATRESH — Matrix Reshape
 - MATSING — SVD Decomposition
 - MATSUM — Sum of Matrix's Elements
 - MATTRAN — Matrix Transpose
 - MATZCONJ — Conjugate of Matrix's Elements
 - RICC — Riccati Equation
 - ROOTCOEF — Polynomial Coefficient Computation
 - SUBMAT — Sub-matrix Extraction
 
 - Port & Subsystem palette
 - Signal processing palette
- Signalprocessing_pal — Signal processing palette
 - QUANT_f — Quantization
 - SAMPHOLD_m — Sample and hold
 
 - Signal routing palette
- Signalrouting_pal — Signal routing palette
 - DEMUX — Demultiplexer
 - EXTRACTOR — Extractor
 - FROM — FROM Receives data from a corresponding GOTO
 - FROMMO — Receives data from a corresponding GOTOMO
 - GOTO — GOTO Pass block input to From block
 - GOTOMO — Pass block input to FROMMO block
 - GotoTagVisibility — Define Scope of GOTO tag visibility
 - GotoTagVisibilityMO — Define Scope of GOTOMO tag visibility
 - ISELECT_m — Iselect
 - MUX — Multiplexer
 - M_SWITCH — Multi-port switch
 - NRMSOM_f — Merge data
 - RELAY_f — Relay
 - SELECT_m — Select
 - SWITCH2_m — Switch2
 - SWITCH_f — Switch
 
 - Sinks palette
- Sinks_pal — Sinks palette
 - AFFICH_m — Display
 - CANIMXY — y=f(x) animated viewer
 - CANIMXY3D — z=f(x,y) animated viewer
 - CFSCOPE — Floating point scope
 - CMAT3D — Matrix z values 3D viewer
 - CMATVIEW — Matrix Colormapped viewer
 - CMSCOPE — Multi display scope
 - CSCOPE — Single Display Scope
 - CSCOPXY — y=f(x) permanent viewer
 - CSCOPXY3D — z=f(x,y) permanent viewer
 - ENDBLK — END block
 - END_c — END_c block
 - TOWS_c — Data to Scilab worspace
 - TRASH_f — Trash block
 - WFILE_f — Write to file
 - WRITEAU_f — Write AU sound file
 - WRITEC_f — Write binary data
 
 - Sources palette
- Sources_pal — Sources palette
 - CLOCK_c — Activation clock
 - CONST_m — Constant
 - CURV_f — Curve
 - Counter — Counter
 - FROMWSB — Data from Scilab workspace to Xcos
 - GENSIN_f — Sine wave generator
 - GENSQR_f — Square wave generator
 - Modulo_Count — Modulo counter (0 to N counter)
 - RAMP — Ramp
 - RAND_m — Random generator
 - READAU_f — Read AU sound file
 - READC_f — Read binary data
 - RFILE_f — Read from input file
 - SAWTOOTH_f — Sawtooth generator
 - STEP_FUNCTION — Step Function
 - SampleCLK — Sample Time Clock
 - Sigbuilder — Signal creator/generator
 - TIME_f — Time
 - TKSCALE — Adjust value with a graphical widget.
 
 - Thermohydraulics palette
- ThermoHydraulics_pal — Thermal-Hydraulics toolbox
 - Bache — Thermal-hydraulic tank (reservoir)
 - PerteDP — Thermal-hydraulic pipe
 - PuitsP — Thermal-hydraulic drain (well)
 - SourceP — Thermal-hydraulic constant pressure source
 - VanneReglante — Thermal-hydraulic control valve
 
 - User defined functions palette
- Userdefinedfunctions_pal — User defined functions palette
 - CBLOCK — New C
 - DSUPER — Masked super block
 - EXPRESSION — Mathematical expression
 - MBLOCK — Modelica generic block
 - SUPER_f — Super block
 - c_block — C language
 - fortran_block — Fortran
 - generic_block3 — Generic block
 - scifunc_block_m — Scilab function block
 
 - Zero crossing detection palette
- Zerocrossingdetection_pal — Zero crossing detection palette
 - GENERAL_f — GENERAL_f title
 - NEGTOPOS_f — Threshold negative to positive
 - POSTONEG_f — Threshold positive to negative
 - ZCROSS_f — Threshold detection at zero
 
 
 - Annotations palette
 - Programming xcos Blocks
- C Computational Functions
 - Scilab Computational Functions
- sci_struct — Scicos block structure of a scilab computational function
 
 - Utilities Functions
- curblock — Return the current called xcos block during the simulation
 - getblocklabel — Get the label of a scicos block
 - getscicosvars — Supervisor utility function
 - phase_simulation — Get the current simulation phase
 - pointer_xproperty — Get the type of a continuous time state variable
 - scicos_time — Returns the current time during simulation
 - set_blockerror — set the block error number
 - set_xproperty — Set the type of a continuous time state variable
 
 
 - Scilab Data Structures
- Blocks
- scicos_block — Define a block structure
 - scicos_graphics — Define a graphics structure
 - scicos_model — Define a model structure
 
 - Compilation/Simulation
- scicos_cpr — Compiled Scicos structure
 - scicos_sim — Define a sim structure
 - scicos_state — Define a state structure
 
 - Diagram
- scicos_diagram — Define a scs_m structure
 - scicos_params — Define a param structure
 
 - Links
- scicos_link — Define a link structure
 
 
 - Blocks
 - Scilab Utilities Functions
- block_parameter_error — Displays a parameter input error box for an Xcos block
 - buildouttb — Build of the sublist %cpr.state.outtb
 - create_palette — Palette generator
 - getModelicaPath — Get the Modelica directory path needed by Xcos diagram containing Modelica blocks
 - get_scicos_version — Get the current Scicos version
 - importXcosDiagram — Import an Xcos diagram on Scilab
 - loadScicos — Load the Xcos simulation native library.
 - loadXcosLibs — Load most of the Xcos macros
 - scicos_debug — Set the level of the Scicos debugging
 - var2vec — Transform a scilab variable in a vector of double
 - vec2var — Transform a vector of double in a scilab variable
 - xcosPal — Instanciate a new Xcos palette on Scilab.
 - xcosPalAdd — Add a palette to the Scilab/Xcos palette manager. Optional property can be added to set the category of the palette.
 - xcosPalAddBlock — Add a block to a Scilab/Xcos palette instance. Some optional properties can be added to customize the palette icon and the style of the block.
 - xcosPalExport — Export a palette instance to a path.
 
 - xcos — Block diagram editor and GUI for the hybrid simulator
 - xcos_menu_entries — Xcos editor menu entries
 
 - Batch functions
 - Spreadsheet
 - Shell
 - Console
- console — Keyboard Shortcuts in the Console Window
 
 - Completion
- completion — returns words that start with the text you pass as parameter.
 
 - History manager
- addhistory — add lines to current history.
 - displayhistory — displays current scilab history
 - gethistory — returns current scilab history in a string matrix
 - gethistoryfile — get filename used for scilab's history
 - historymanager — enable or disable history manager
 - historysize — get number of lines in history
 - loadhistory — load a history file
 - removelinehistory — remove the Nth line in history.
 - resethistory — Deletes all entries in the scilab history.
 - saveafterncommands — Save the history file after n statements are added to the file.
 - saveconsecutivecommands — Save consecutive duplicate commands.
 - savehistory — save the current history in a file
 - sethistoryfile — set filename for scilab history
 
 - Matlab binary files I/O
- loadmatfile — loads a Matlab V6 MAT-file (binary or ASCII) into Scilab
 - matfile_close — Closes a Matlab V5 binary MAT-file.
 - matfile_listvar — Lists variables of a Matlab V5 binary MAT-file.
 - matfile_open — Opens a Matlab V5 binary MAT-file.
 - matfile_varreadnext — Reads next variable in a Matlab V5 binary MAT-file.
 - matfile_varwrite — Write a variable in a Matlab V5 binary MAT-file.
 - savematfile — write a Matlab MAT-file (binary or ASCII)
 
 - Matlab to Scilab Conversion Tips
- Matlab-Scilab equivalents
- A
- m2sci_abs — Absolute value and complex magnitude
 - m2sci_acos — Inverse cosine
 - m2sci_acosh — Inverse hyperbolic cosine
 - m2sci_acot — Inverse cotangent
 - m2sci_acoth — Inverse hyperbolic cotangent
 - m2sci_acsc — Inverse cosecant
 - m2sci_acsch — Inverse hyperbolic cosecant
 - m2sci_all — Test to determine if all elements are nonzero
 - m2sci_angle — Phase angle
 - m2sci_any — Test to determine if any nonzeros elements
 - m2sci_asec — Inverse secant
 - m2sci_asech — Inverse hyperbolic secant
 - m2sci_asin — Inverse sine
 - m2sci_asinh — Inverse hyperbolic sine
 - m2sci_atan — Two-quadrant inverse tangent
 - m2sci_atan2 — Four-quadrant inverse tangent
 - m2sci_atanh — Inverse hyperbolic tangent
 
 - B
- m2sci_balance — Diagonal scaling to improve eigenvalue accuracy
 - m2sci_bar — Bar histogram
 - m2sci_barh — Bar histogram horizontal
 - m2sci_beep — Produce a beep sound
 - m2sci_besseli — Modified Bessel functions of the first kind
 - m2sci_besselj — Bessel functions of the first kind
 - m2sci_besselk — Modified Bessel functions of the second kind
 - m2sci_bessely — Bessel functions of the second kind
 - m2sci_beta — Beta function
 - m2sci_bin2dec — Returns the integer corresponding to a Given binary representation
 - m2sci_bitand — The AND of two integers
 - m2sci_bitcmp — The binary complementary of an integer
 - m2sci_bitget — Gets the bit of an integer whose the positon is given in the input argument
 - m2sci_bitor — The OR of two integers
 - m2sci_bitxor — Returns the exclusive OR of two integers
 - m2sci_blanks — A string of blanks
 - m2sci_box — Display axes border
 - m2sci_break — Terminate execution of a for loop or while loop
 
 - C
- m2sci_case — Case switch
 - m2sci_cat — Arrays concatenation
 - m2sci_cd — Change/get working directory
 - m2sci_ceil — Round up
 - m2sci_cell — Create cell array
 - m2sci_cell2mat — Convert a cell array into a matrix
 - m2sci_cellstr — Convert strings vector (or strings matrix) into a cell of strings
 - m2sci_chol — Cholesky factorization
 - m2sci_cla — Clear current axes
 - m2sci_clc — Clear Command Window
 - m2sci_clear — Remove items from workspace, freeing up system memory
 - m2sci_clf — Clear current figure window
 - m2sci_clock — Current time as a date vector
 - m2sci_close — Delete specified figure
 - m2sci_closereq — Default figure close request function
 - m2sci_colordef — Set default property values to display different color schemes
 - m2sci_complex — Returns the complex form corresponding to the given real part and imaginary part
 - m2sci_continue — Keyword to pass control to the next iteration of a loop
 - m2sci_conv — Convolution
 - m2sci_cos — Cosine
 - m2sci_cosh — Hyperbolic cosine
 - m2sci_cot — Cotangent
 - m2sci_coth — Hyperbolic cotangent
 - m2sci_cputime — Elapsed CPU time
 - m2sci_csc — Cosecant
 - m2sci_csch — Hyperbolic cosecant
 - m2sci_cumprod — Cumulative product
 - m2sci_cumsum — Cumulative sum
 - m2sci_conj — Complex conjugate
 
 - D
- m2sci_date — Current date string
 - m2sci_dec2bin — The binary representation of a decimal number
 - m2sci_dec2hex — Decimal to hexadecimal number conversion
 - m2sci_delete — Delete files or graphics objects
 - m2sci_det — Determinant
 - m2sci_diag — Diagonal including or extracting
 - m2sci_diary — Save session to a file
 - m2sci_diff — Differences and approximate derivatives
 - m2sci_dir — Display directory listing
 - m2sci_disp — Display text or array
 - m2sci_display — Overloaded method to display an object
 - m2sci_doc — Display online documentation
 - m2sci_docopt — Web browser for UNIX platforms
 - m2sci_dos — Execute a UNIX command and return result
 - m2sci_double — Conversion to double precision
 - m2sci_drawnow — Complete pending drawing events
 
 - E
- m2sci_echo — Echo lines during execution
 - m2sci_eig — Find eigenvalues and eigenvectors
 - m2sci_else — Conditionally execute statements
 - m2sci_elseif — Conditionally execute statements
 - m2sci_erf — Error function
 - m2sci_erfc — Complementary error function
 - m2sci_erfcx — Scaled complementary error function
 - m2sci_error — Display error messages
 - m2sci_etime — Elapsed time
 - m2sci_eval — Execute a string containing an instruction/expression
 - m2sci_exist — Check if a variable or file exists
 - m2sci_exit — Ends current session
 - m2sci_exp — Exponential
 - m2sci_expm — Matrix exponential
 - m2sci_eye — Identity matrix
 
 - F
- m2sci_factor — Prime numbers decomposition
 - m2sci_false — False array
 - m2sci_fclose — Close one or more open files
 - m2sci_feof — Test for end-of-file
 - m2sci_ferror — Query about errors in file input or output
 - m2sci_feval — Function evaluation
 - m2sci_fft — Discrete Fourier transform
 - m2sci_fftshift — Shift zero-frequency component of discrete Fourier transform to center of spectrum
 - m2sci_fgetl — Read line(s) from file, discard newline character
 - m2sci_fgets — Read line from file, keep newline character
 - m2sci_fileparts — Return filename parts
 - m2sci_filesep — Return the directory separator for this platform
 - m2sci_find — Find indices and values of nonzero elements
 - m2sci_findstr — Find one string within another
 - m2sci_fix — Round towards zero
 - m2sci_fliplr — Flip matrix in left/right direction
 - m2sci_flipud — Flip matrix in up/down direction
 - m2sci_floor — Round down
 - m2sci_fopen — Open a file or obtain information about open files
 - m2sci_for — Repeat statements a specific number of times
 - m2sci_format — Control display format for output
 - m2sci_fprintf — Write formatted data to file
 - m2sci_fread — Read binary data to a file
 - m2sci_frewind — Move the file position indicator to the beginning of an open file
 - m2sci_fscanf — Read formatted data to file
 - m2sci_fseek — Set file position indicator
 - m2sci_ftell — Get file position indicator
 - m2sci_full — Convert sparse matrix to full matrix
 - m2sci_fullfile — Build a full filename from parts
 - m2sci_function — Function definition
 - m2sci_fwrite — Write binary data to a file
 
 - G
- m2sci_gamma — Gamma function
 - m2sci_gammaln — Logarithm of gamma function
 - m2sci_getenv — Get environment variable
 - m2sci_global — Define a global variable
 - m2sci_graymon — Set graphics defaults for gray-scale monitors
 - m2sci_grid — Grid lines for two- and three-dimensional plots
 
 - H
- m2sci_hankel — Hankel matrix
 - m2sci_help — Display help
 - m2sci_helpdesk — Display Help browser
 - m2sci_helpwin — Provide access to and display help for all functions
 - m2sci_hess — Hessenberg form of a matrix
 - m2sci_hold — Hold current graph
 - m2sci_home — Move the cursor to the upper left corner of the Command Window
 - m2sci_horzcat — Horizontal concatenation
 - m2sci_helpbrowser — Display Help browser for access to full online documentation
 
 - I
- m2sci_if — Conditionally execute statements
 - m2sci_ifft — Inverse discrete Fourier transform
 - m2sci_imag — Complex imaginary part
 - m2sci_input — Request user input
 - m2sci_int16 — Convert to 16-bit signed integer
 - m2sci_int32 — Convert to 32-bit signed integer
 - m2sci_int8 — Convert to 8-bit signed integer
 - m2sci_interp1 — One_dimension interpolation function
 - m2sci_inv — Matrix inverse
 - m2sci_isa — Detect an object of a given type
 - m2sci_iscell — Determine if input is a cell array
 - m2sci_ischar — Determine if item is a character array
 - m2sci_isdir — Determine if item is a directory
 - m2sci_isempty — True for empty matrix
 - m2sci_isequal — Determine if arrays are numerically equal
 - m2sci_isfield — Determine if input is a structure array field
 - m2sci_isfinite — True for finite elements
 - m2sci_isglobal — Determine if item is a global variable
 - m2sci_ishandle — Determines if values are valid graphics object handles
 - m2sci_ishold — Return hold state
 - m2sci_isinf — True for infinite elements
 - m2sci_isinteger — Detect whether an array has integer data type
 - m2sci_isletter — True for letters of the alphabet
 - m2sci_islogical — Determine if item is a logical array
 - m2sci_isnan — Detect NaN elements of an array
 - m2sci_isnumeric — Determine if input is a numeric array
 - m2sci_ispc — Determine if PC (Windows) version
 - m2sci_isreal — Determine if all array elements are real numbers
 - m2sci_isscalar — Determine if input is scalar
 - m2sci_isspace — Detect elements that are ASCII white spaces
 - m2sci_isstr — Determine if item is a character array
 - m2sci_isstruct — Determine if input is a structure array
 - m2sci_isunix — Determine if Unix version
 - m2sci_isvector — Determine if input is a vector
 - m2sci_issparse — Test if matrix is sparse
 
 - K
- m2sci_keyboard — Invoke the keyboard in a file
 - m2sci_kron — Kronecker tensor product
 
 - L
- m2sci_length — Length of vector
 - m2sci_linspace — Linearly spaced vector
 - m2sci_load — Load workspace variables from disk
 - m2sci_log — Natural logarithm
 - m2sci_log10 — Common (base 10) logarithm
 - m2sci_log2 — Base 2 logarithm and dissect floating point number
 - m2sci_logical — Convert numeric values to logical
 - m2sci_lookfor — Search for specified keyword in all help entries
 - m2sci_lower — Convert string to lower case
 - m2sci_lu — LU matrix factorization
 
 - M
- m2sci_max — Maximum
 - m2sci_min — Minimum
 - m2sci_mkdir — Make new folder
 - m2sci_mod — Modulus after division
 - m2sci_more — Display Command Window output one screenful at a time
 
 - N
- m2sci_nargin — Number of function input arguments
 - m2sci_nargout — Number of function output arguments
 - m2sci_ndims — Number of array dimensions
 - m2sci_norm — Vector and matrix norms
 - m2sci_num2str — Number to string conversion
 
 - O
- m2sci_ones — Create an array of all ones
 - m2sci_otherwise — Default part of switch/select statement
 - m2sci_pause — Halt execution temporarily
 
 - Operators
- m2sci_addition — Plus
 - m2sci_and — Logical AND
 - m2sci_colon — Colon
 - m2sci_elementwise_left_division — Elementwise left division
 - m2sci_elementwise_multiplication — Elementwise multiplication
 - m2sci_elementwise_power — Elementwise exponent
 - m2sci_elementwise_right_division — Elementwise right division
 - m2sci_elementwise_transpose — Elementwise transpose
 - m2sci_equal — Equal to
 - m2sci_great — Greater than
 - m2sci_great_equal — Greater or equal to
 - m2sci_left_division — Left division
 - m2sci_less — Smaller than
 - m2sci_less_equal — Smaller or equal to
 - m2sci_multiplication — Multiplication
 - m2sci_not — Negation
 - m2sci_not_equal — Not equal to
 - m2sci_or — Logical OR
 - m2sci_power — Exponent
 - m2sci_right_division — Right division
 - m2sci_substraction — Minus
 - m2sci_transpose — Transpose
 
 - P
- m2sci_perms — Array of all permutations of vector components
 - m2sci_permute — Permute the dimensions of an array
 - m2sci_pie — circular graphic
 - m2sci_plot — Linear 2-D plot
 - m2sci_pow2 — Base 2 power and scale floating-point numbers
 - m2sci_primes — Returns the primes numbers included between 1 and given number
 - m2sci_prod — Product of array elements
 
 - Q
- m2sci_qr — Orthogonal-triangular decomposition
 - m2sci_quit — Terminate session
 
 - R
- m2sci_rand — Uniformly distributed random numbers and arrays
 - m2sci_randn — Normally distributed random numbers and arrays
 - m2sci_rcond — Matrix reciprocal condition number estimate
 - m2sci_real — Real part of a complex number
 - m2sci_realmax — Largest positive floating-point number
 - m2sci_realmin — Smallest positive floating-point number
 - m2sci_rem — Remainder after division
 - m2sci_repmat — Replicate and tile an array
 - m2sci_reshape — Reshape array
 - m2sci_return — Return to the invoking function
 - m2sci_round — Round to nearest integer
 
 - S
- m2sci_save — Save workspace variables from disk
 - m2sci_schur — Schur decomposition
 - m2sci_setstr — Set string flag
 - m2sci_sign — Signum function
 - m2sci_sin — Sine
 - m2sci_sinh — Hyperbolic sine
 - m2sci_size — Array dimension
 - m2sci_sort — Sort elements in ascending order
 - m2sci_sparse — Create sparse matrix
 - m2sci_sqrt — Square root
 - m2sci_strcmp — Compare strings
 - m2sci_strcmpi — Compare strings ignoring case
 - m2sci_strfind — Find one string within another
 - m2sci_strrep — String search and replace
 - m2sci_struct — Create struct array
 - m2sci_sum — Sum of array elements
 - m2sci_surf — 3-D surface plot
 - m2sci_svd — Singular value decomposition
 - m2sci_switch — Switch among several cases based on expression
 
 - T
- m2sci_tan — Tangent
 - m2sci_tanh — Hyperbolic tangent
 - m2sci_tic — Starts a stopwatch timer
 - m2sci_title — Display a title on a graphic window
 - m2sci_toc — Read the stopwatch timer
 - m2sci_toeplitz — Toeplitz matrix
 - m2sci_tril — Lower triangular part of a matrix
 - m2sci_triu — Upper triangular part of a matrix
 - m2sci_true — True array
 - m2sci_type — List file
 
 - U
- m2sci_uigetdir — Standard dialog box for selecting a directory
 - m2sci_uint16 — Convert to 16-bit unsigned integer
 - m2sci_uint32 — Convert to 32-bit unsigned integer
 - m2sci_uint8 — Convert to 8-bit unsigned integer
 - m2sci_unix — Execute a UNIX command and return result
 - m2sci_upper — Convert string to upper case
 
 - V
- m2sci_varargin — Pass variable numbers of arguments
 - m2sci_varargout — Return variable numbers of arguments
 - m2sci_vertcat — Vertical concatenation
 
 - Variables
 - W
- m2sci_waitforbuttonpress — Wait for key or mouse button press
 - m2sci_warning — Display warning messages
 - m2sci_while — Repeat statements an indefinite number of times
 - m2sci_who — List variables in the workspace
 - m2sci_whos — List variables in the workspace
 - m2sci_winqueryreg — Get item from Microsoft Windows registry
 
 - X
- m2sci_xlabel — Display a string along the x axis
 
 - Y
- m2sci_ylabel — Display a string along the y axis
 
 - Z
- m2sci_zlabel — Display a string along the z axis
 - m2sci_zeros — Create an array of all zeros
 
 
 - A
 - About_M2SCI_tools — Generally speaking about tools to convert Matlab files to Scilab
 - Contents — Create a tree containing contents inference data
 - Cste — Create a tree representing a constant
 - Equal — Create a tree representing an instruction
 - Funcall — Create a tree representing a function call
 - Infer — Create a tree containing inference data
 - MatlabScilab_character_strings — Generally speaking about...
 - Operation — Create a tree representing an operation
 - Type — Create a tree containing type inference data
 - Variable — Create a tree representing a variable
 - get_contents_infer — Search for information in a "M2SCi tlist" contents
 - m2scideclare — Giving tips to help M2SCI...
 - matfile2sci — converts a Matlab 5 MAT-file into a Scilab binary file
 - mfile2sci — Matlab M-file to Scilab conversion function
 - sci_files — How to write conversion functions
 - translatepaths — convert a set of Matlab M-files directories to Scilab
 
 - Matlab-Scilab equivalents
 - Compatibility Functions
- asciimat — string matrix ascii conversions
 - firstnonsingleton — Finds first dimension which is not 1
 - makecell — Creates a cell array.
 - mstr2sci — character string matrix to character matrix conversion
 - mtlb_0 — Matlab non-conjugate transposition emulation function
 - mtlb_a — Matlab addition emulation function
 - mtlb_all — Matlab all emulation function
 - mtlb_any — Matlab any emulation function
 - mtlb_axis — Matlab axis emulation function
 - mtlb_beta — Matlab beta emulation function
 - mtlb_box — Matlab box emulation function
 - mtlb_close — Matlab close emulation function
 - mtlb_colordef — Matlab colordef emulation function
 - mtlb_conv — Matlab conv emulation function
 - mtlb_cumprod — Matlab cumprod emulation function
 - mtlb_cumsum — Matlab cumsum emulation function
 - mtlb_dec2hex — Matlab dec2hex emulation function
 - mtlb_delete — Matlab delete emulation function
 - mtlb_diag — Matlab diag emulation function
 - mtlb_diff — Matlab diff emulation function
 - mtlb_dir — Matlab dir emulation function
 - mtlb_double — Matlab double emulation function
 - mtlb_e — Matlab extraction emulation function
 - mtlb_echo — Matlab echo emulation function
 - mtlb_eval — Matlab eval emulation function
 - mtlb_exist — Matlab exist emulation function
 - mtlb_eye — Matlab eye emulation function
 - mtlb_false — Matlab false emulation function
 - mtlb_fft — Matlab fft emulation function
 - mtlb_fftshift — Matlab fftshift emulation function
 - mtlb_find — Matlab find emulation function
 - mtlb_findstr — Matlab findstr emulation function
 - mtlb_fliplr — Matlab fliplr emulation function
 - mtlb_fopen — Matlab fopen emulation function
 - mtlb_format — Matlab format emulation function
 - mtlb_fprintf — Matlab fprintf emulation function
 - mtlb_fread — Matlab fread emulation function
 - mtlb_fscanf — Matlab fscanf emulation function
 - mtlb_full — Matlab full emulation function
 - mtlb_fwrite — Matlab fwrite emulation function
 - mtlb_grid — Matlab grid emulation function
 - mtlb_hold — Matlab hold emulation function
 - mtlb_i — Matlab insertion emulation function
 - mtlb_ifft — Matlab ifft emulation function
 - mtlb_imp — Matlab colon emulation function
 - mtlb_int16 — Matlab int16 emulation function
 - mtlb_int32 — Matlab int32 emulation function
 - mtlb_int8 — Matlab int8 emulation function
 - mtlb_is — Matlab string insertion emulation function
 - mtlb_isa — Matlab isa emulation function
 - mtlb_isfield — Matlab isfield emulation function
 - mtlb_isletter — Matlab isletter emulation function
 - mtlb_isspace — Matlab isspace emulation function
 - mtlb_l — Matlab left division emulation function
 - mtlb_legendre — Matlab legendre emulation function
 - mtlb_linspace — Matlab linspace emulation function
 - mtlb_logic — Matlab logical operators emulation function
 - mtlb_logical — Matlab logical emulation function
 - mtlb_lower — Matlab lower emulation function
 - mtlb_max — Matlab max emulation function
 - mtlb_min — Matlab min emulation function
 - mtlb_more — Matlab more emulation function
 - mtlb_num2str — Matlab num2str emulation function
 - mtlb_ones — Matlab ones emulation function
 - mtlb_plot — Matlab plot emulation function
 - mtlb_prod — Matlab prod emulation function
 - mtlb_rand — Matlab rand emulation function
 - mtlb_randn — Matlab randn emulation function
 - mtlb_rcond — Matlab rcond emulation function
 - mtlb_realmax — Matlab realmax emulation function
 - mtlb_realmin — Matlab realmin emulation function
 - mtlb_repmat — Matlab repmat emulation function
 - mtlb_s — Matlab substraction emulation function
 - mtlb_setstr — Matlab setstr emulation function
 - mtlb_size — Matlab size emulation function
 - mtlb_sort — Matlab sort emulation function
 - mtlb_strcmp — Matlab strcmp emulation function
 - mtlb_strcmpi — Matlab strcmpi emulation function
 - mtlb_strfind — Matlab strfind emulation function
 - mtlb_strrep — Matlab strrep emulation function
 - mtlb_sum — Matlab sum emulation function
 - mtlb_t — Matlab transposition emulation function
 - mtlb_toeplitz — Matlab toeplitz emulation function
 - mtlb_tril — Matlab tril emulation function
 - mtlb_triu — Matlab triu emulation function
 - mtlb_true — Matlab true emulation function
 - mtlb_uint16 — Matlab uint16 emulation function
 - mtlb_uint32 — Matlab uint32 emulation function
 - mtlb_uint8 — Matlab uint8 emulation function
 - mtlb_upper — Matlab upper emulation function
 - mtlb_var — Matlab var emulation function
 - mtlb_zeros — Matlab zeros emulation function
 
 - Maple Interface
- sci2map — Scilab to Maple variable conversion
 
 - Overloading
- overloading — display, functions and operators overloading capabilities
 
 - Functions
- profiling
- add_profiling — Adds profiling instructions to a function.
 - plotprofile — extracts and displays execution profiles of a Scilab function
 - profile — extract execution profiles of a Scilab function
 - remove_profiling — Removes profiling instructions toout of a function.
 - reset_profiling — Resets profiling counters of a function.
 - showprofile — extracts and displays execution profiles of a Scilab function
 
 - bytecode — given a function returns the "bytecode" of a function in a Scilab array and conversely.
 - bytecodewalk — walk in function bytecode applying transformation.
 - deff — on-line definition of function
 - exec — script file execution
 - execstr — execute Scilab code in strings
 - fun2string — generates ascii definition of a scilab function
 - function — closes a function definition
 - functions — Scilab procedures and Scilab objects
 - genlib — build library from functions in given directory
 - get_function_path — get source file path of a library function
 - getd — getting all functions defined in a directory
 - head_comments — display scilab function header comments
 - lib — library definition
 - librarieslist — get scilab libraries
 - library — library datatype description
 - libraryinfo — get macros and path of a scilab library
 - listfunctions — properties of all functions in the workspace
 - macro — Scilab procedure and Scilab object
 - macrovar — variables of function
 - recompilefunction — recompiles a scilab function, changing its type
 - varargin — variable numbers of arguments in an input argument list
 - varargout — variable numbers of arguments in an output argument list
 - whereis — name of library containing a function
 
 - profiling
 - Development tools
 - Demo Tools
- demo_begin — begin a demonstration
 - demo_choose — create a dialog box for the choice of options
 - demo_compiler — test the presence of a compileur
 - demo_end — completes a demonstration
 - demo_file_choice — choose and executes an item within a list
 - demo_function_choice — choose and execute an item within a list
 - demo_mdialog — create a dialog box
 - demo_message — display a message
 - demo_run — script file execution
 
 - Dynamic/incremental Link
- G_make — call make or nmake
 - addinter — new functions interface dynamic link at run time.
 - c_link — check incremental/dynamic link
 - call — Fortran or C user routines call
 - chooselcccompiler — moved as toolbox in ATOMS
 - configure_msifort — set environments variables for Intel Fortran Compiler (Windows).
 - configure_msvc — set environments variables for Microsoft C Compiler.
 - dllinfo — provides information about the format and symbols provided in executable and DLL files (Windows).
 - findmsifortcompiler — detects Intel fortran Compiler
 - findmsvccompiler — detects Microsoft C Compiler
 - fort — Fortran or C user routines call
 - getdynlibext — get the extension of dynamic libraries on your operating system.
 - haveacompiler — detect if you have a C compiler.
 - ilib_build — utility for shared library management
 - ilib_compile — ilib_build utility: executes the Makefile produced by ilib_gen_Make
 - ilib_for_link — utility for shared library management with link
 - ilib_gen_Make — utility for ilib_build: produces a Makefile for building shared libraries
 - ilib_gen_cleaner — utility for ilib_build: generates a cleaner file
 - ilib_gen_gateway — utility for ilib_build, generates a gateway file.
 - ilib_gen_loader — utility for ilib_build: generates a loader file
 - ilib_include_flag — Return a formated includes related string to pass to system compiler
 - ilib_mex_build — utility for mex library management
 - ilib_verbose — set level of display used by dynamic link functions.
 - link — dynamic linker
 - supported_compilers —
 - ulink — unlink a dynamically linked shared object
 
 - ATOMS
- _atomsGettingStarted —
 - atoms —
 - atomsAutoloadAdd — Add one or several modules to autoload
 - atomsAutoloadDel — Remove one or several modules from the autoload system
 - atomsAutoloadList — Get the list of modules registered to autoload
 - atomsCategoryList — List available categories
 - atomsDepTreeShow — Show the dependency tree of a module
 - atomsGetInstalled — Get the list of installed external modules
 - atomsGetLoaded — Get the list of loaded external modules
 - atomsInstall — Install one or several external modules
 - atomsIsInstalled — Determines whether the module is installed. Returns true if the module is installed, false otherwise.
 - atomsIsLoaded — determines whether a module is loaded or not
 - atomsList — List available external modules
 - atomsLoad — Install one or several external modules
 - atomsRemove — Remove one or several modules
 - atomsRepositoryAdd — Add one or several URLs to the list of managed repositories
 - atomsRepositoryDel — Remove one or several URLs from the list of managed repositories
 - atomsRepositoryList — Get the list of managed repositories
 - atomsSearch — Searches for external modules.
 - atomsSetConfig — Manage ATOMS system parameters
 - atomsShow — Show the caracteristics of a module
 - atomsSystemUpdate — Update the list of available modules
 - atomsUpdate — Update one or several external modules
 
 - Tcl/Tk Interface
- ScilabEval — tcl instruction : Evaluate a string with scilab interpreter
 - TCL_CreateSlave — Create a TCL slave interpreter
 - TCL_DeleteInterp — delete TCL interpreter
 - TCL_EvalFile — Reads and evaluate a tcl/tk file
 - TCL_EvalStr — Evaluate a string whithin the Tcl/Tk interpreter
 - TCL_ExistArray — Return %T if a tcl array exists
 - TCL_ExistInterp — Return %T if a tcl slave interperter exists
 - TCL_ExistVar — Return %T if a tcl variable exists
 - TCL_GetVar — Get a tcl/tk variable value
 - TCL_GetVersion — get the version of the TCL/TK library at runtime.
 - TCL_SetVar — Set a tcl/tk variable value
 - TCL_UnsetVar — Remove a tcl variable
 - TCL_UpVar — Make a link from a tcl source variable to a tcl destination variable
 - config — Scilab general configuration.
 - winclose — close windows created by sciGUI
 - winlist — Return the winId of current window created by sciGUI
 
 - Text editor (Scinotes)
- edit_error — opens in scilab editor the source of the last recorded error
 - editor — Scinotes: Embedded Scilab text editor
 
 - UI Data
 - Online help management
- add_help_chapter — Add an entry in the help list
 - apropos — searches keywords in Scilab help
 - del_help_chapter — Delete an entry in the help list
 - help — on-line help command
 - help_from_sci — Generate help files and demo files from the head comments section of a .sci source file.
 - help_skeleton — build the skeleton of the xml help file associated to a Scilab function
 - how_to_link_toolbox_help — How to make hyperlink in toolbox help pointing to Scilab's items
 - man — on line help XML file description format
 - manedit — editing a manual item
 - percenthelps — Variable defining the path of help directories
 - xmltochm — converts xml Scilab help files to Microsoft Compressed HTML format (Windows)
 - xmltohtml — converts xml Scilab help files to HTML format
 - xmltojar — converts xml Scilab help files to javaHelp format
 - xmltopdf — converts xml Scilab help files to pdf format
 - xmltops — converts xml Scilab help files to postscript format
 
 - Parallel
- parallel_concurrency — query about the concurrency of the current execution context
 - parallel_run — parallel calls to a function
 
 - PVM parallel Toolbox
- pvm — communications with other applications using Parallel Virutal Machine
 - pvm_addhosts — add hosts to the virtual machine.
 - pvm_barrier — blocks the calling process until all processes in a group have called it.
 - pvm_bcast — broacasts a message to all members of a group
 - pvm_bufinfo — Returns information about a message buffer.
 - pvm_config — sends a message
 - pvm_delhosts — deletes hosts from the virtual machine.
 - pvm_error — Prints message describing an error returned by a PVM call
 - pvm_exit — tells the local pvmd that this process is leaving PVM.
 - pvm_f772sci — Convert a F77 complex into a complex scalar
 - pvm_get_timer — Gets the system's notion of the current time.
 - pvm_getinst — returns the instance number in a group of a PVM process.
 - pvm_gettid — returns the tid of the process identified by a group name and instance number
 - pvm_gsize — returns the number of members presently in the named group.
 - pvm_halt — stops the PVM daemon
 - pvm_joingroup — enrolls the calling process in a named group.
 - pvm_kill — Terminates a specified PVM process.
 - pvm_lvgroup — Unenrolls the calling process from a named group.
 - pvm_mytid — returns the tid of the calling process.
 - pvm_parent — tid of the process that spawned the calling process.
 - pvm_probe — Check if message has arrived.
 - pvm_recv — receive a message.
 - pvm_reduce — Performs a reduce operation over members of the specified group
 - pvm_sci2f77 — Convert complex scalar into F77
 - pvm_send — immediately sends (or multicast) data.
 - pvm_set_timer — Sets the system's notion of the current time.
 - pvm_spawn — Starts new Scilab processes.
 - pvm_spawn_independent — Starts new PVM processes.
 - pvm_start — Start the PVM daemon
 - pvm_tasks — information about the tasks running on the virtual machine.
 - pvm_tidtohost — returns the host of the specified PVM process.
 - pvmd3 — PVM daemon
 
 - Modules manager
- tbx_build_blocks — Compile blocks (toolbox compilation process)
 - tbx_build_cleaner — Generate a cleaner.sce script (toolbox compilation process)
 - tbx_build_gateway — Build a gateway (toolbox compilation process)
 - tbx_build_gateway_clean — Generate a cleaner_gateway.sce script (toolbox compilation process)
 - tbx_build_gateway_loader — Generate a loader_gateway.sce script (toolbox compilation process)
 - tbx_build_help — Generate help files (toolbox compilation process)
 - tbx_build_help_loader — Generate a addchapter.sce script (toolbox compilation process)
 - tbx_build_loader — Generate a loader.sce script (toolbox compilation process)
 - tbx_build_macros — Compile macros (toolbox compilation process)
 - tbx_build_src — Build sources (toolbox compilation process)
 - tbx_builder_gateway — Run builder_gateway.sce script if it exists (toolbox compilation process)
 - tbx_builder_gateway_lang — Run builder_gateway_(language).sce script if it exists (toolbox compilation process)
 - tbx_builder_help — Run builder_help.sce script if it exists (toolbox compilation process)
 - tbx_builder_help_lang — Run build_help.sce script if it exists (toolbox compilation process)
 - tbx_builder_macros — Run buildmacros.sce script if it exists (toolbox compilation process)
 - tbx_builder_src — Run builder_src.sce script if it exists (toolbox compilation process)
 - tbx_builder_src_lang — Run builder_(language).sce script if it exists (toolbox compilation process)
 
 - Localization
- dgettext — get text translated into the current locale and a specific domain domain.
 - getdefaultlanguage — getdefaultlanguage() returns the default language used by Scilab.
 - getlanguage — getlanguage() returns current language used by Scilab.
 - gettext — get text translated into the current locale and domain.
 - LANGUAGE — Variable defining the language (OBSOLETE)
 - setdefaultlanguage — sets and saves the internal LANGUAGE value.
 - setlanguage — Sets the internal LANGUAGE value.
 - _ — get text translated into the current locale and domain.
 
 - JVM
- javaclasspath — set and get dynamic Java class path
 - javalibrarypath — set and get dynamic java.library.path
 - jre_path — returns Java Runtime Environment used by Scilab
 - system_getproperty — gets the system property indicated by a specified key.
 - system_setproperty — set a system property indicated by a specified key and value.
 - with_embedded_jre — checks if scilab uses a embedded JRE
 
 - API Scilab
- boolean
- isBooleanType — Check if it is a boolean variable.
 - getScalarBoolean — Read scalar boolean data from a gateway argument.
 - createScalarBoolean — Create scalar boolean variable in Scilab memory.
 - booleanExample — Boolean use case.
 
 - Boolean Sparse
- isBooleanSparseType — Check if it is a boolean sparse variable.
 - getAllocatedBooleanSparseMatrix — Get sparse matrix attributs.
 - freeAllocatedBooleanSparse — Free memory allocated by getAllocatedBooleanSparseMatrix function.
 - booleanSparseExample — Boolean sparse use case.
 
 - Scilab Gateway API
- How to
- CallingAScilabFunctionFromACInterface — Calling a scilab function (macros) from a C interface
 
 - CheckLhs — C macro which checks the number of output arguments present in the calling Scilab function.
 - CheckRhs — C macro which checks the number of input arguments present in the calling Scilab function.
 - Lhs — A C gateway function which provides the number of output arguments present in the calling Scilab function
 - LhsVar — a C gateway function which specifies which parameters created inside the C gateway will be returned as an output argument into Scilab.
 - Rhs — A C gateway function which provides the number of input arguments present in the calling Scilab function
 - Scierror — C gateway function which displays an error message to the user (same profil as the printf function) and returns an integer value specifying an error level
 - sci_types — a C enumeration which defines the types available for a variable
 - sciprint — A C gateway function which displays standard messages to the user (same profil as the C printf function)
 
 - How to
 - double
- isDoubleType — Check if it is a double variable.
 - getScalarDouble — Get scalar double variable.
 - getScalarComplexDouble — Get scalar complex double variable.
 - createScalarDouble — Create a scalar double in Scilab memory.
 - createScalarComplexDouble — Create a scalar complex double in Scilab memory.
 - doubleExample — Double use case.
 
 - integer
- isIntegerType — Check if it is a double variable.
 - getScalarInteger8 — Get scalar integer variable.
 - createScalarInteger8 — Create scalar integer variable.
 - integerExample — Integer use case.
 
 - List manipulation
- list_boolean_reading_API — How to read matrix of boolean in a list.
 - list_boolean_writing_API — How to add matrix of boolean in a list.
 - list_bsparse_reading_API — How to read boolean sparse in a list.
 - list_bsparse_writing_API — How to add boolean sparse matrix in a list.
 - list_createlist_API — How to get create a list in Scilab memory.
 - list_double_reading_API — How to read matrix of double in a list.
 - list_double_writing_API — How to add matrix of double in a list.
 - list_getlistitemaddress_API — How to get the address of a list child.
 - list_getlistitemnumber_API — How to get the number of items in a list (list, mlist, tlist).
 - list_integer_reading_API — How to read matrix of integer in a list.
 - list_integer_writing_API — How to add matrix of integer in a list.
 - list_pointer_reading_API — How to read pointer in a list.
 - list_pointer_writing_API — How to add pointer in a list.
 - list_poly_reading_API — How to read matrix of polynomial in a list.
 - list_poly_writing_API — How to add matrix of polynomial in a list.
 - list_sparse_reading_API — How to read sparse in a list.
 - list_sparse_writing_API — How to add sparse matrix in a list.
 - list_string_reading_API — How to read matrix of string in a list.
 - list_string_writing_API — How to add matrix of string in a list.
 
 - Low level functions
- boolean_reading_API — How to read matrix of boolean.
 - boolean_writing_API — How to write matrices of boolean.
 - bsparse_reading_API — How to read boolean sparse in a gateway.
 - bsparse_writing_API — How to add boolean sparse matrix in a gateway.
 - Common_getvaraddr_API — How to get the address of an argument or a variable in a gateway.
 - Common_getvardimension_API — How to get the dimensions of an argument or a variable stored as matrix.
 - Common_getvartype_API — How to get the type of an argument or a variable within a gateway.
 - Common_iscomplex_API — How to get the argument or variable complexity.
 - Common_isvarmatrixtype_API — How to know if an argument or a variable is stored as a matrix.
 - Double_management_reading_API — How to read matrices of double in a gateway.
 - Double_management_writing_API — How to write matrices of doubles in a gateway.
 - int_getmatrixofintegerprecision_API — How to get precision of an integer matrix.
 - Integer_management_reading_API — How to read matrices of integer in a gateway.
 - Integer_management_writing_API — How to write matrices of integers in a gateway.
 - Pointer_reading_API — How to read pointer in a gateway.
 - Pointer_writing_API — How to write pointer in a gateway.
 - poly_getpolyvariablename_API — How to get the symbolic variable name.
 - Polynomial_management_reading_API — How to read matrices of polynomials in a gateway.
 - Polynomial_management_writing_API — How to write matrices of polynomials in a gateway.
 - Sparse_management_reading_API — How to read sparse matric in a gateway.
 - Sparse_management_writing_API — How to write sparse matrix in a gateway.
 - String_management_reading_API — How to read matrices of strings in a gateway.
 - String_management_writing_API — How to write matrices of string in a gateway.
 
 - polynom
- isPolyType — Check if it is a polynom variable.
 - getAllocatedSinglePoly — Get single polynom variable.
 - getAllocatedSingleComplexPoly — Get single complex polynom variable.
 - getAllocatedMatrixOfPoly — Get matrix of polynom variable.
 - getAllocatedMatrixOfComplexPoly — Get matrix of complex polynom variable.
 - freeAllocatedSinglePoly — Free memory allocated by getAllocatedSinglePoly function.
 - freeAllocatedSingleComplexPoly — Free memory allocated by getAllocatedSingleComplexPoly function.
 - freeAllocatedMatrixOfPoly — Free memory allocated by getAllocatedSinglePoly function.
 - freeAllocatedMatrixOfComplexPoly — Free memory allocated by getAllocatedSinglePoly function.
 - polyExample — Polynom use case.
 
 - sparse
- isSparseType — Check if it is a sparse variable.
 - getAllocatedSparseMatrix — Get sparse matrix variable.
 - getAllocatedComplexSparseMatrix — Get complex sparse matrix variable.
 - freeAllocatedSparseMatrix — Free memory allocated by getAllocatedSparseMatrix function.
 - freeAllocatedComplexSparseMatrix — Free memory allocated by getAllocatedComplexSparseMatrix function.
 - sparseExample — Sparse use case.
 
 - string
- isStringType — Check if it is a string variable.
 - getAllocatedSingleString — Get single string variable.
 - getAllocatedMatrixOfString — Get matrix of polynom variable.
 - createSingleString — create a single string variable.
 - freeAllocatedSingleString — Free memory allocated by getAllocatedSinglePoly function.
 - freeAllocatedMatrixOfString — Free memory allocated by freeAllocatedMatrixOfString function.
 - stringExample — String use case.
 
 - api_scilab — api_scilab is the Scilab interface to read/write data from/to Scilab memory
 
 - boolean
 - call_scilab API (Scilab engine)
- BooleanManagement_callscilab — How to manage Scilab's boolean read and write process using call_scilab and api_scilab
 - ComplexManagement_callscilab — How to manage Scilab's complex variable read and write process using call_scilab
 - DisableInteractiveMode — Disables some features (plotting, gui creation, Tcl/Tk...) and leaves only the computing engine
 - DoubleManagement_callscilab — How to manage Scilab's variable read and write process using call_scilab and api_scilab
 - GetLastJob — Returns the latest job sent to Scilab engine
 - ScilabHaveAGraph — Check if any Scilab graphics have been opened.
 - SendScilabJob — Send a Scilab task from a C/C++ code (call_scilab)
 - SendScilabJobs — Send Scilab tasks from a C/C++ code (call_scilab)
 - StartScilab — Initializes and starts Scilab engine in Call Scilab
 - StringManagement_callscilab — How to manage Scilab's String read and write process using call_scilab and api_scilab
 - TerminateScilab — Stops and terminates Scilab engine in Call Scilab
 - call_scilab — call_scilab is an interface which provides the ability to call Scilab engine from C/C++ code
 - compile_and_run_call_scilab — How to compile a native application based on or using Scilab
 - creadbmat — Read a single boolean or a matrix of boolean from Scilab memory using call_scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: Boolean reading for remplacement.
 - creadchain — Read a single string from Scilab memory using call_scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: String reading for remplacement.
 - creadcmat — Read a single complex or a matrix of complex from Scilab memory using call_scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: Complex double reading for remplacement.
 - creadmat — Read a single double or a matrix of double from Scilab memory using call_scilab. Note that it is the default datatype in Scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: Double reading for remplacement.
 - cwritebmat — Write a single boolean or a matrix of boolean into Scilab memory using call_scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: Boolean writing for remplacement.
 - cwritechain — Write a single string into Scilab memory using call_scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: String writing for remplacement.
 - cwritecmat — Write a single complex or a matrix of complex into Scilab memory using call_scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: Complex double writing for remplacement.
 - cwritemat — Write a single double or a matrix of double into Scilab memory using call_scilab. Note that it is the default datatype in Scilab. Starting with Scilab 5.2, this function is obsolete. See API_Scilab: Double writing for remplacement.
 - fromc — Checks if current Scilab is called from an external C program (by StartScilab).
 - fromjava — Checks if current Scilab is called from javasci
 
 - Java Interface
- Javasci v1 (deprecated)
- SciBoolean — Class to use boolean object with scilab. Deprecated: Please use Javasci v2
 - SciBooleanArray — Class to use boolean matrix in Scilab. Deprecated: Please use Javasci v2
 - SciComplex — Class to use complex object with scilab. Deprecated: Please use Javasci v2
 - SciComplexArray — Class to use complex matrix in Scilab. Deprecated: Please use Javasci v2
 - SciDouble — Class to use double object with scilab. Deprecated: Please use Javasci v2
 - SciDoubleArray — Class to use real matrix in Scilab. Deprecated: Please use Javasci v2
 - SciInteger — Class to use integer object with scilab. Deprecated: Please use Javasci v2
 - SciIntegerArray — Class to use int matrix in Scilab. Deprecated: Please use Javasci v2
 - SciString — Map a Java String into a Scilab string. Deprecated: Please use Javasci v2
 - SciStringArray — Classe to use String matrix in Scilab. Deprecated: Please use Javasci v2
 - javasci.Scilab — This class provides the basic methods to execute Scilab code and scripts. Deprecated: Please use Javasci v2
 - compile_and_run_javasci_v1 — How to compile a Java application using Javasci v1. Deprecated: Please use Javasci v2
 - javasci_faq_v1 — The frequently asked questions - Javasci v1. Deprecated: Please use Javasci v2
 
 - compile_and_run_javasci_v2 — How to compile a Java application using Javasci v2
 - javasci — Call Scilab engine from a Java application
 - javasci_faq_v2 — The frequently asked questions for Javasci v2
 - javasci_v1_limitations — Why javasci v1 is now deprecated ?
 - javasci_step_by_step — How to write an application based on javasci v2
 
 - Javasci v1 (deprecated)
 - Intersci
- intersci — Scilab tool to interface C or Fortran functions with scilab