scilab-branch-2026.0 
      
      
     
    
      
       
      
      Scilab Help 
Scilab 
Scilab keywords 
backslash  — (\) left matrix division: Exact or least square solution  
brackets [,;]  — Concatenation. Recipients of an assignment. Results of a function  
colon (:)  — Ranging operator. Addresses all elements along an array dimension or of a list.  
comma  — (,) comma; instruction, argument separator  
comments  — (// or /*...*/) comments  
comparison  — comparison, relational operators  
dollar  — ($) last index  
dot  — (.) symbol  
equal  — (=) assignment , comparison, equal sign  
getscilabkeywords  — returns a list with all scilab
            keywords.  
hat  — (^) exponentiation  
less  — (<) less than comparison  
minus  — (-) subtraction operator. Sign change  
not  — (~) logical not  
parentheses  — ( ) left and right parenthesis  
percent  — (%) special character  
plus (+)  — Numerical addition. Text concatenation (gluing)  
quote  — (') transpose operator, string delimiter  
semicolon  — (;) ending expression and row separator  
slash  — (/) right divisions. System's feed back. Comments  
star  — (*) multiplication operator  
symbols  — scilab operator names  
tilde  — (~) logical not  
underscore _  — ignored output argument. gettext() alias  
Control flow 
abort  — interrupt evaluation.  
arguments  — keyword to check function arguments. Arguments block must be the expression in the function.  
Arguments Validators  — List of predefined validators that can be used in arguments  block.  
break  — keyword to interrupt loops  
case  — keyword used in statement "select"  
continue  — keyword to pass control to the next
            iteration of a loop  
do  — language keyword for loops  
else  — keyword in if-then-else and select-case-then-else  
elseif  — keyword in if-then-else  
end  — end keyword  
for  — keyword entering a non-conditional loop  
halt  — stop execution  
if  — keyword for conditional execution  
pause  — temporarily pauses the running execution, and allows instructions in console.  
resume  — return or resume execution and copy some local variables  
return  — return or resume execution and copy some local variables  
select  — select keyword  
then  — keyword in control flows 'if' and 'select'  
try  — beginning of try block in try-catch control
            instruction  
while  — Opens a block of instructions iterated on a heading condition  
Configuration 
banner  — shows Scilab banner  
getdebuginfo  — get information about Scilab to debug  
getmemory  — returns free and total system memory  
getmodules  — lists modules installed in Scilab  
getos  — return Operating System name and version  
getscilabmode  — returns scilab mode  
getshell  — returns current command interpreter  
getversion  — get scilab and modules version information  
oldEmptyBehaviour  — Controls the operation+ and operation- behaviour for Scilab  
recursionlimit  — get or set the current or maximal allowed depth of nested calls  
sciargs  — scilab command line arguments  
ver  — Version information for Scilab  
with_javasci  — Checks if Scilab has been built with
            the Java interface  
with_macros_source  — Checks if macros sources are installed  
with_module  — Checks if a Scilab module is
            installed  
Debugging 
debug  — enters the Scilab CLI debugger mode  
where  — get current instruction calling tree  
whereami  — display current instruction calling tree  
Error handling 
errclear  — clears the last error (if its number matches a given one)  
error  — reports a run time error  
error_table  — list of main standard errors messages  
lasterror  — get last recorded error message  
warning  — warning messages  
types 
boolean  — Scilab Objects, boolean variables and operators & | ~  
Classdef and objects  — Classdef and objects  
functions  — Scilab procedures and Scilab objects  
hypermatrices  — a Scilab object, N dimensional matrix in Scilab  
isa  — checks variable type  
Lambda functions  — Scilab procedures and Scilab objects  
library  — library datatype  
matrices  — Scilab objects, matrices in Scilab  
rational  — rational fractions  
strings  — Character strings  
type  — returns the type of a Scilab object  
typename  — associates a name to variable type  
typeof  — explicit type or overloading code of an object  
Variables 
Constants 
SCI, WSCI  — variable containing the value of the root path of Scilab.  
SCIHOME  — contains the path to preferences, history files of your Scilab
            session.  
TMPDIR  — temporary directory path  
home  — Gives the user directory.  
%chars  — Selected sets of Unicode characters  
%e  — Euler number.  
%eps  — epsilon (floating-point relative accuracy)  
%f or %F  — Boolean variable for false.  
%i, 1i, 1j  — imaginary unit  
%inf  — infinity  
%nan  — not-a-number  
%pi  — ratio of circle's circumference to its diameter  
%s  — A variable used to define polynomials.  
%t or %T  — Boolean variable for true.  
%z  — A variable used to define polynomials.  
checkNamedArguments  — Return list of unexpected named arguments  
clear  — kills variables  
clearglobal  — kills global variables  
enumeration  — Get enumeration of a classdef or an object  
exists  — checks variable existence  
global  — Define global variable  
isdef  — checks variable existence  
isglobal  — checks if a local variable has a global counterpart  
methods  — Get accessible methods of a classdef or an object  
names  — Naming rules for variables and functions  
predef  — variable protection  
properties  — Get accessible properties of a classdef or an object  
who  — listing of variables  
who_user  — listing of user's variables  
whos  — listing of variables in long form  
exit  — Ends the current Scilab session  
quit  — Terminates Scilab or  decreases the pause level  
startup  — startup files  
scilab  — runs Scilab in interactive or batch mode with command line options.  
Differential Equations 
 
Elementary Functions 
Bitwise operations 
bitand  — bitwise logical AND between element-wise integers of 2 arrays  
bitcmp  — bitwise complement of integers  
bitget  — Extracts from integers bits of given indices  
bitor  — bitwise logical OR between element-wise integers of 2 arrays  
bitset  — Sets bits of given indices in some integers  
bitstring  — A string giving the literal bit representation of a number  
bitxor  — bitwise logical XOR between element-wise integers of 2 arrays  
Complex numbers 
angle  — argument of complex numbers, in radians  
complex  — Build an array of complex numbers from their parts  
conj  — Complex conjugate  
csgn  — returns the sign of a vector of real of complex values  
imag  — imaginary part of complex numbers, polynomials, or rationals  
imult  — multiplication by i the imaginary unitary  
isreal  — check if a variable is stored as a complex matrix  
real  — real part of complex numbers, polynomials, or rationals  
Discrete mathematics 
factor  — factor function  
factorial  — factorial function : product of the n first positive integers  
gcd  — Greatest (positive) Common Divisor  
lcm  — least common (positive) multiple of integers or of polynomials  
 nchoosek  — Computes binomial numbers (n,k) = numbers of combinations  
primes  — lists of primes up to a given number  
rat  — Floating point rational approximation  
Matrix generation 
random 
grand  — Generate random numbers  
prbs_a  — Generates a pseudo random binary sequence  
rand  — Random numbers  
sample  — Sampling: random draw with replacement  
samplef  — sample values with replacement from a population
            with given frequencies.  
samwr  — Sampling without replacement  
blockdiag  — Creates a block diagonal matrix from provided arrays. Block diagonal system connection.  
companion  — companion matrix  
diag  — diagonal including or extracting  
empty []  — empty matrix. Array ranges destructor.  
eye  — identity matrix  
 frank  — Frank matrix  
 gallery  — generate test matrices  
 hadamard  — Hadamard matrix  
 hankel  — Hankel matrix  
 hilbm  — Hilbert matrix  
 invhilb  — Inverse of the Hilbert matrix  
linspace  — generates linearly spaced numbers between 2 reached bounds  
logspace  — logarithmically spaced vector  
 magic  — Magic square  
meshgrid  — Create matrices or 3-D arrays from vectors replicated in 2 or 3 dimensions  
ndgrid  — build matrices or N-D arrays by replicating some template vectors  
ones  — matrix made of ones  
 pascal  — Pascal matrix  
perms  — Generate the table of permutations of given elements  
repmat  — Replicate and tile an array  
 rosser  — Rosser matrix  
squarewave  — generates a square wave with period 2*%pi  
toeplitz  — Toeplitz matrix (chosen constant diagonal bands)  
 vander  — Vandermonde matrix  
 wilkinson  — Wilkinson matrix  
zeros  — null matrix  
Log - exp - power 
exp  — element-wise exponential  
expm  — square matrix exponential  
log  — natural logarithm  
log10  — base 10 logarithm  
log1p  — computes with accuracy the natural logarithm of its argument
            added by one  
log2  — Base-2 logarithm. Base-2 exponent and mantissa of some real numbers  
logm  — square matrix logarithm  
nthroot  — Real nth root of real numbers  
power  — (^,.^) power operation  
sqrt  — square root  
sqrtm  — matrix square root  
Floating point 
ceil  — round up  
clean  — cleans matrices (round to zero small entries)  
double  — converts inttype integers or booleans into decimal encoding  
fix  — round towards zero  
floor  — round down  
format  — set the default output format of decimal numbers  
ieee  — sets or gets the floating point exception mode  
int  — round towards zero  
isinf  — tests for infinite elements  
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  
signed zero -0  — Processing of -0 versus 0  
Radix conversions 
base2dec  — convert from base b to decimal  
bin2dec  — convert from binary to decimal  
dec2base  — Convert decimal to base N number in string  
dec2bin  — convert from decimal to binary  
dec2hex  — convert from decimal to hexadecimal  
dec2oct  — convert from decimal to octal  
hex2dec  — convert from hexadecimal to decimal  
oct2dec  — convert from octal to decimal  
Integers 
iconvert  — conversion to 1 to 8 byte integer representation  
int8  — conversion to one byte integer representation  
inttype  — type integers used in integer data types  
Matrix - shaping 
Shape tests 
iscolumn  — check if a variable is a column  
ismatrix  — checks if an object is a non-empty 1D or 2D matrix or array  
isrow  — check if a variable is a row  
isscalar  — check if a variable is a scalar.  
issquare  — check if a variable is a square matrix  
isvector  — check if a variable is a vector  
cat  — stacks vectors matrices or arrays into an hypermatrix or hyperarray  
circshift  — circularly shifts elements or subarrays of an array (regular, of structures, cells, custom)  
flipdim  — reverses the order of (blocks of) rows, columns, pages.. of an array  
matrix  — reshapes an array with the same number and order of components  
permute  — permutes the dimensions of an array  
pertrans  — Transposition with reference to the 2nd diagonal  
resize_matrix  — trim or/and extend (and cast) a matrix or hypermatrix  
squeeze  — removes singleton dimensions of a ND-array  
tril  — lower triangular part of matrix  
triu  — upper triangle  
Matrix operations 
abs  — absolute value, magnitude  
and  — logical AND between the elements of a boolean or numerical array  
cross  — vector cross product  
cumprod  — cumulative product of array elements  
cumsum  — partial cumulative sums of the elements of an array  
kron .*.  — Kronecker tensorial product. Weighted array replication  
kron .\. ./.  — Kronecker left and right divisions  
max  — maximum  
min  — minimum  
norm  — norms of a vector or a matrix  
or  — logical OR over the elements of a boolean or numerical array  
prod  — product of array elements  
sign  — signum function  
sum  — sum of array elements  
Search and sort 
dsearch  — distribute, locate and count elements of a matrix or hypermatrix in given categories  
find  — gives the indices of %T or non-zero elements  
gsort  — sorts boolean, numerical and string arrays  
members  — count (and locate) in an array each element or row or column of another array  
sortrows  — Sort rows of a vector, matrix, table, or timeseries  
vectorfind  — locates occurences of a (wildcarded) vector in a matrix or hypermatrix  
Set operations 
intersect  — elements or rows or columns met in both input arrays, without duplicates  
setdiff  — returns elements that are in a set but not in another one.  
union  — Set of all elements, rows, or columns of two arrays, without duplicates  
unique  — extracts (and sorts) distinct elements, rows or columns of a matrix  
Trigonometry 
Conversions 
cart2pol  — Convert cartesian coordinates to polar/cylindrical  
pol2cart  — Convert polar/cylindrical coordinates to cartesian  
Matrix-wise processing 
acoshm  — matrix hyperbolic inverse cosine  
acosm  — matrix wise cosine inverse  
asinhm  — matrix hyperbolic inverse sine  
asinm  — matrix wise sine inverse  
atanhm  — matrix hyperbolic tangent inverse  
atanm  — square matrix tangent inverse  
coshm  — matrix hyperbolic cosine  
cosm  — matrix cosine function  
cothm  — matrix hyperbolic cotangent  
sinhm  — matrix hyperbolic sine  
sinm  — matrix sine function  
tanhm  — matrix hyperbolic tangent  
tanm  — matrix tangent  
acos  — element wise cosine inverse (radians)  
acosd  — element wise cosine inverse, result in degree.  
acosh  — hyperbolic cosine inverse  
acot  — computes the element-wise inverse cotangent of the
            argument.  
acotd  — computes the element-wise inverse cotangent of the argument,
            result in degree.  
acoth  — element wise hyperbolic cotangent 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  
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  
cos  — cosine function  
cosd  — element-wise cosine function, argument in degree  
cosh  — hyperbolic cosine  
cotd  — element-wise cotangent function, argument in degree  
cotg  — cotangent  
coth  — hyperbolic cotangent  
csc  — сomputes the element-wise cosecant of the
            argument  
cscd  — сomputes the element-wise cosecant of the argument given in
            degree  
csch  — Computes the element-wise hyperbolic cosecant of the
            argument.  
sec  — computes the element-wise secant of the argument  
secd  — computes the element-wise secant of the argument given in
            degree  
sech  — computes the element-wise hyperbolic secant of the
            argument  
sin  — sine function  
sind  — sine function, argument in degree.  
sinh  — hyperbolic sine  
tan  — tangent  
tand  — tangent, argument in degree.  
tanh  — hyperbolic tangent  
&, &&  — Binary AND between integers. Logical AND over/between booleans and numbers  
bernstein  — compute the n-order Bernstein matrix  
extraction  — matrix and list entry extraction  
ind2sub  — linear index to matrix subscript values  
insertion  — partial variable assignation
            or   modification  
isempty  — check if a variable is an empty matrix or an empty
            list  
isequal  — tests the strict global equality between several objects, without equivalences  
modulo  — remainder modulo m with the sign of the left operand, or of a polynomial division  
ndims  — number of dimensions of an array  
|, ||  — Binary OR between integers. Logical OR over/between booleans and numbers  
size  — size of objects  
sub2ind  — matrix subscript values to linear index  
Linear Algebra 
Eigenvalue and Singular Value 
balanc  — matrix or pencil balancing  
bdiag  — block diagonalization, generalized eigenvectors  
eigs  — calculates largest eigenvalues and eigenvectors of matrices  
pbig  — eigen-projection  
projspec  — spectral operators  
psmall  — spectral projection  
spec  — eigenvalues, and eigenvectors of a matrix or a pencil  
sva  — singular value approximation  
svd  — singular value decomposition  
Factorization 
chol  — Cholesky factorization  
fullrf  — full rank factorization  
fullrfk  — full rank factorization of A^k  
hess  — Hessenberg form  
lu  — LU factorization with pivoting  
polar  — polar decomposition of a square matrix  
qr  — QR decomposition  
rankqr  — rank revealing QR factorization  
schur  — [ordered] Schur decomposition of matrix and pencils  
sqroot  — W*W' hermitian factorization  
Kernel 
colcomp  — column compression, kernel, nullspace  
im_inv  — inverse image  
kernel  — kernel, null space  
range  — range (span) of A^k  
rowcomp  — row compression, range  
Linear Equations 
aff2ab  — linear (affine) function to A,b conversion  
inv  — matrix inverse  
linsolve  — linear equation solver  
lsq  — linear least square solution of A*X=B with minimal norm(X)  
pinv  — pseudoinverse  
Markov Matrices 
classmarkov  — recurrent and transient classes of Markov matrix  
eigenmarkov  — normalized left and right Markov eigenvectors  
genmarkov  — generates random markov matrix with recurrent and transient classes  
Matrix Analysis 
cond  — condition number of a matrix  
det  — determinant of a square matrix  
orth  — orthogonal basis  
rank  — rank  
rcond  — inverse condition number  
rref  — computes  matrix row echelon form by lu transformations  
trace  — trace  
Matrix Pencil 
ereduc  — computes  matrix column echelon form by qz transformations  
fstair  — computes  pencil  column echelon form by qz transformations  
glever  — inverse of matrix pencil  
kroneck  — Kronecker form of matrix pencil  
lyap  — Lyapunov equation  
pen2ea  — pencil to E,A conversion  
pencan  — canonical form of matrix pencil  
penlaur  — Laurent coefficients of matrix pencil  
quaskro  — quasi-Kronecker form  
randpencil  — random pencil  
rowshuff  — shuffle algorithm  
State-Space Matrices 
coff  — resolvent (cofactor method)  
nlev  — Leverrier's algorithm  
Subspaces 
spaninter  — subspace intersection  
spanplus  — sum of subspaces  
spantwo  — sum and intersection of subspaces  
givens  — Givens transformation  
householder  — Householder orthogonal reflexion matrix. Symetrical wrt a plane  
proj  — projection  
Interpolation 
bezier  — compute the points for the bezier curve  
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  — 1D interpolation in nearest, linear or spline mode  
interp2d  — bicubic spline (2d) evaluation function  
interp3d  — 3d spline evaluation function  
interpln  — linear interpolation  
linear_interpn  — n dimensional linear interpolation  
lsq_splin  — weighted least squares cubic spline fitting  
mesh2d  — Triangulation of n points in the plane  
smooth  — smoothing by spline functions  
splin  — cubic spline interpolation  
splin2d  — bicubic spline gridded 2d interpolation  
splin3d  — spline gridded 3d interpolation  
Control Systems - CACSD 
Control Design 
Control Loop 
augment  — augmented plant  
feedback  — feedback operation  
lft  — linear fractional transformation  
H-infinity 
ccontrg  — Central H-infinity continuous time controller  
dhinf  — H_infinity design of discrete-time systems  
dhnorm  — discrete H-infinity norm  
gamitg  — H-infinity gamma iterations for continuous time systems  
h2norm  — H2 norm of a continuous time proper dynamical system  
h_cl  — closed loop matrix  
h_inf  — Continuous time H-infinity (central) controller  
h_inf_st  — static H_infinity problem  
h_norm  — H-infinity norm  
hinf  — H_infinity design of continuous-time systems  
linf  — infinity norm  
linfn  — infinity norm  
macglov  — Continuous time dynamical systems Mac Farlane Glover problem  
nehari  — Nehari approximant of continuous time dynamical systems  
parrot  — Parrot's problem  
Linear Quadratic 
fourplan  — augmented plant to four plants  
gcare  — Continuous time control Riccati equation  
gfare  — Continuous time filter Riccati equation  
leqr  — H-infinity LQ gain (full state)  
lqe  — linear quadratic estimator (Kalman Filter)  
lqg  — LQG compensator  
lqg2stan  — LQG to standard problem  
lqg_ltr  — LQG with loop transform recovery  
lqi  — Linear quadratic integral compensator (full state)  
lqr  — LQ compensator (full state)  
Pole Placement 
kpure  — continuous SISO system limit feedback gain  
krac2  — continuous SISO system limit feedback gain  
ppol  — pole placement  
stabil  — stabilization  
ddp  — disturbance decoupling  
gfrancis  — Francis equations for tracking  
Identification 
arl2  — SISO model realization by L2 transfer approximation  
armax  — armax identification  
armax1  — armax identification  
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  
imrep2ss  — state-space realization of an impulse response  
inistate  — Estimates the initial state of a discrete-time system  
lin  — linearization  
sident  — discrete-time state-space realization and Kalman gain  
sorder  — computing the order of a discrete-time system  
time_id  — SISO least square identification  
Linear Analysis 
Controllability Observability 
abinv  — AB invariant subspace  
cainv  — Dual of abinv  
cont_mat  — controllability matrix  
contr  — controllability, controllable subspace, staircase  
contrss  — controllable part  
ctr_gram  — controllability gramian  
dt_ility  — detectability test  
obs_gram  — observability gramian  
obscont  — observer based controller  
observer  — observer design  
obsv_mat  — observability matrix  
obsvss  — observable part  
ui_observer  — unknown input observer  
unobs  — unobservable subspace  
Frequency Domain 
black  — Black-Nichols diagram of a linear dynamical system  
bode  — Bode plot  
bode_asymp  — Bode plot asymptote  
calfrq  — frequency response discretization  
dbphi  — frequency response to phase and magnitude representation  
freq  — frequency response  
freson  — peak frequencies  
gainplot  — magnitude plot  
hallchart  — Draws a Hall chart  
nicholschart  — Nichols chart  
nyquist  — nyquist plot  
nyquistfrequencybounds  — Computes the frequencies for which the nyquist locus enters and leaves a given rectangle.  
phasemag  — phase and magnitude
            computation  
phaseplot  — frequency phase plot  
repfreq  — frequency response  
svplot  — singular-value sigma-plot  
trzeros  — transmission zeros and normal rank  
Stability 
bstap  — hankel approximant  
dtsi  — Continuous time dynamical systems stable anti-stable decomposition  
evans  — Evans root locus  
g_margin  — gain margin and associated crossover frequency  
p_margin  — phase margin and associated crossover frequency  
plzr  — pole-zero plot  
routh_t  — Routh's table  
sgrid  — draws a s-plane grid  
show_margins  — display gain and phase margin  and associated crossover frequencies  
st_ility  — stabilizability test  
zgrid  — zgrid plot  
Time Domain 
arsimul  — armax simulation  
csim  — simulation (time response) of linear system  
damp  — Natural frequencies and damping factors.  
dsimul  — state space discrete time simulation  
flts  — time response (discrete time, sampled system)  
ltitr  — discrete time response (state space)  
narsimul  — armax simulation (using rtitr)  
rtitr  — discrete time response (transfer matrix)  
sensi  — sensitivity functions  
Linear System Factorization 
colinout  — inner-outer factorization  
copfac  — right coprime factorization of continuous time dynamical systems  
dcf  — double coprime factorization  
fspec  — spectral factorization of continuous time dynamical systems  
fspecg  — stable factorization of continuous time dynamical systems  
fstabst  — Youla's parametrization of continuous time linear dynamical systems  
gtild  — tilde operation  
lcf  — Continuous time dynamical systems normalized coprime factorization  
rowinout  — inner-outer factorization  
specfact  — spectral factor  
sysfact  — system factorization  
Linear System Representation 
abcd  — state-space matrices  
arma  — Scilab arma library  
arma2p  — extract polynomial matrices from ar representation  
arma2ss  — transform an armax data structure into state space
            representation.  
armac  — Scilab description of an armax process  
bloc2ss  — block-diagram to state-space conversion  
cont_frm  — transfer to controllable state-space  
des2ss  — descriptor to state-space  
des2tf  — descriptor to transfer function conversion  
frep2tf  — transfer function realization from frequency response  
lsslist  — Scilab linear state space function definition  
markp2ss  — Markov parameters to state-space  
pfss  — partial fraction decomposition  
pol2des  — polynomial matrix to descriptor form  
sm2des  — system matrix to descriptor  
sm2ss  — system matrix to state-space  
ss2des  — (polynomial) state-space to descriptor form  
ss2ss  — state-space to state-space conversion, feedback,
            injection  
ss2tf  — conversion from state-space to transfer function  
ss2zp  — SIMO state space system to zero pole gain representation  
ssprint  — pretty print for linear system  
ssrand  — random system generator  
sysconv  — system conversion  
syslin  — linear system definition  
syssize  — size of state-space system  
systmat  — system matrix  
tf2des  — transfer function to descriptor  
tf2ss  — transfer to state-space  
tf2zp  — SIMO transfer function to zero pole gain representation  
trfmod  — poles and zeros display  
zp2ss  — Zero pole gain to  state space  
zp2tf  — Zero pole gain to transfer function  
zpk  — Zero pole gain system representation  
zpk2ss  — Zero pole gain to state space  
zpk2tf  — Zero pole gain to transfer function  
Matrix Computation 
linmeq  — Sylvester and Lyapunov equations solver  
mucomp  — mu (structured singular value) calculation  
ricc  — Riccati equation  
riccati  — Solves the matricial Riccati equation (continuous | discrete time domain)  
signm  — matrix signum function  
sylv  — Solve the Sylvester equations A*X + X*B = C or A*X*B + X = C  
Model Transformation 
arhnk  — Hankel norm approximant  
balreal  — balanced realization  
bilin  — general bilinear transform  
canon  — canonical controllable form  
cls2dls  — bilinear transform  
colregul  — removing poles and zeros at infinity  
dscr  — discretization of linear system  
equil  — balancing of pair of symmetric matrices  
equil1  — balancing (nonnegative) pair of matrices  
hankelsv  — Hankel singular values  
invsyslin  — system inversion  
minreal  — minimal balanced realization  
minss  — minimal realization  
projsl  — linear system projection  
rowregul  — removing poles and zeros at infinity  
zeropen  — zero pencil  
Polynomials 
bezout  — GCD of two polynomials or two integers, by the Bezout method  
chepol  — Chebychev polynomials  
cmndred  — common denominator form  
coeff  — polynomial coefficients  
coffg  — Co-factors of a matrix of polynomials or rationals  
colcompr  — column compression of polynomial matrix  
degree  — degree of polynomial matrix  
derivat  — derivative of polynomials or of rationals  
determ  — determinant of a matrix of polynomials  
detr  — determinant of a matrix of rationals  
diophant  — Solves the diophantine (Bezout) equation p1*x1 + p2*x2 = b  
factors  — factorization in ℝ of a polynomial or a rational fraction  
hermit  — Hermite form  
horner  — evaluates some polynomials or rationals for given values  
hrmt  — gcd of polynomials  
htrianr  — triangularization of polynomial matrix  
inv_coeff  — build a polynomial matrix from its coefficients  
invr  — inverts a matrix of polynomials or of rationals  
lcmdiag  — least common multiple diagonal factorization  
ldiv  — polynomial matrix long division  
pdiv  — polynomial division  
pol2str  — polynomial to string conversion  
polfact  — minimal real factors of a polynomial  
poly  — Polynomial definition from given roots or coefficients, or characteristic to a square matrix.  
polyDisplay  — set or get the display mode of polynomials  
polyint  — Polynomial integration  
residu  — residue  
roots  — roots of a polynomial  
rowcompr  — row compression of polynomial matrix  
sfact  — discrete time spectral factorization  
simp  — rational simplification  
simp_mode  — toggle rational simplification  
sylm  — Sylvester matrix of two polynomials  
varn  — symbolic variable of a polynomial or a rational  
Signal Processing 
Convolution - Correlation 
conv  — discrete 1-D convolution.  
conv2  — discrete 2-D convolution.  
convol  — convolution  
convol2d  — discrete 2-D convolution, using fft.  
corr  — correlation, covariance  
hank  — covariance to hankel matrix  
xcorr  — Computes discrete auto or cross correlation  
Filters 
How to design an elliptic filter  — How to design an elliptic filter (analog and
            digital)  
analpf  — create analog low-pass filter  
buttmag  — Power transmission of a Butterworth filter  
casc  — cascade realization of filter from coefficients (utility function)  
cheb1mag  — response of Chebyshev type 1 filter  
cheb2mag  — response of type 2 Chebyshev filter  
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  
filt_sinc  — samples of sinc function  
filter  — filters a data sequence using a digital filter  
find_freq  — parameter compatibility for elliptic filter design  
frmag  — magnitude of FIR and IIR filters  
fsfirlin  — design of FIR, linear phase filters, frequency sampling technique  
group  — group delay for digital 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  
kalm  — Kalman update  
lev  — Yule-Walker equations (Levinson's algorithm)  
levin  — Toeplitz system solver by Levinson algorithm
            (multidimensional)  
lindquist  — Lindquist's algorithm  
remez  — Remez exchange algorithm for the weighted chebyshev
            approximation of a continuous function with a sum of cosines.  
remezb  — Minimax approximation of magnitude response  
sgolay  — Savitzky-Golay Filter Design  
sgolaydiff  — Numerical derivatives computation using Savitzky-Golay filter.  
sgolayfilt  — Filter signal using Savitzky-Golay Filter.  
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  
wfir_gui  — Graphical user interface that can be used to interactively design wfir 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  
Identification 
frfit  — frequency response fit  
lattn  — recursive solution of normal equations  
lattp  — Identification of MA part of a vector ARMA process  
mrfit  — frequency response fit  
phc  — Markovian representation  
rpem  — Recursive Prediction-Error Minimization estimation  
Spectral estimation 
cepstrum  — cepstrum calculation  
cspect  — two sided cross-spectral estimate between 2 discrete time signals using
            the correlation method  
czt  — chirp z-transform algorithm  
mese  — maximum entropy spectral estimation  
pspect  — two sided cross-spectral estimate between 2 discrete time signals using
            the Welch's average periodogram method.  
Transforms 
dct  — Discrete cosine transform.  
dst  — Discrete sine transform.  
fft  — Direct or inverse Fast Fourier Transform of a vector, matrix, or hypermatrix  
fft2  — two-dimension fast Fourier
            transform  
fftshift  — rearranges the fft output, moving the zero frequency to the center of the spectrum  
hilb  — FIR approximation to a Hilbert transform filter  
ifftshift  — inverse of fftshift  
bilt  — bilinear or biquadratic transform SISO system given by a zero/poles representation  
detrend  — remove constant, linear or piecewise linear trend from a vector  
intdec  — Changes  sampling rate of a signal  
unwrap  — unwrap a Y(x) profile or a Z(x,y) surface. Unfold a Y(x) profile  
xcov  — Computes discrete auto or cross covariance  
FFTW 
 
Special Functions 
airy  — Airy functions of the first and second kind, and their derivatives  
amell  — Jacobi's am function  
besseli  — Modified Bessel functions of the first kind (Iα ).  
beta  — beta function (Euler integral of the first kind)  
calerf  — computes error functions.  
dawson  — Compute the Dawson (scaled imaginary error) function.  
delip  — complete and incomplete elliptic integral of first
            kind  
dlgamma  — derivative of gammaln function, psi function  
ellipj  — Jacobi elliptic functions  
erf  — The error function.  
erfc  — The complementary error function.  
erfcx  — scaled complementary error function.  
erfi  — The imaginary error function.  
erfinv  — inverse error function  
findm  — for elliptic filter design  
gamma  — gamma function, complete or incomplete normalized  
gammaln  — The logarithm of gamma function.  
legendre  — associated Legendre functions  
%k  — Jacobi's complete elliptic integral of the first kind (vectorized)  
sinc  — sinc function  
sincd  — digital sinc function or Dirichlet kernel  
Statistics 
Cumulated Distribution Functions 
binomial  — binomial distribution probabilities  
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 Fisher 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  
cdftnc  — cumulative distribution function of the non-central Student's T distribution  
Mean Central Tendency 
center  — center  
geomean  — geometric mean  
harmean  — harmonic mean : inverse of the inverses average (without zeros)  
mean  — mean of all values, or means along a given dimension  
meanf  — weighted mean of a vector or a matrix  
median  — median (row median, column median,...) of
            vector/matrix/array entries  
trimmean  — trimmed mean of a vector or a matrix  
wcenter  — center and weight  
Dispersion widths 
iqr  — interquartile range  
mad  — mean absolute deviation  
stdev  — standard deviation (row or column-wise) of vector/matrix entries  
stdevf  — standard deviation  
strange  — range  
variance  — variance (and mean) of a vector or matrix (or hypermatrix) of real or complex numbers  
variancef  — variance (and mean) of a vector or matrix of frequency-weighted real or complex numbers  
Empirical distribution 
cmoment  — central moments of all orders  
histc  — computes the histogram of a simple series of data  
moment  — non central moments of all orders  
perctl  — computation of percentils  
quart  — computation of quartiles  
tabul  — frequency of values of a matrix or vector  
Multivariate Correl Regress PCA 
correl  — correlation of two variables  
cov  — Sample covariance matrix  
covar  — covariance of two variables  
pca  — Computes principal component analysis for the data matrix X  
reglin  — Linear regression  
show_pca  — Visualization of principal components analysis results  
Data with Missing Values 
nancumsum  — This function returns
            the cumulative sum of the values of a matrix  
nand2mean  — difference of the means of
            two independent samples  
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  
nanreglin  — Linear regression  
nanstdev  — standard deviation (ignoring the NANs).  
nansum  — Sum of values ignoring NAN's  
thrownan  — Eliminates nan values  
Hypothesis Testing 
ftest  — Fisher ratio  
ftuneq  — Fisher ratio for samples of unequal size.  
 dbscan  — Density-based clustering (DBSCAN)  
 estimate_bandwidth  — Estimate an appropriate bandwidth for Mean Shift clustering  
 kmeans  — K-means clustering  
 meanshift  — Mean Shift clustering algorithm  
 polyfit  — Polynomial curve fitting  
 polyval  — evaluates the polynomial for given values  
Sparse 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  
res_with_prec  — computes the residual r = Ax-b with precision  
taucs_chdel  — utility function used with taucs_chfact  
taucs_chfact  — cholesky factorization 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  — solves a linear s.p.d. system A*X = B from Cholesky factors of the sparse A  
umf_ludel  — utility function used with umf_lufact  
umf_lufact  — lu factorization 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 
 
XML Management 
XML Objects  — Describe the properties of the different XML objects  
htmlDump  — Dump a HTML document  
htmlRead  — Read a HTML stream from a local or distant file  
htmlReadStr  — Read a HTML tree from a string  
htmlWrite  — Write a HTML document in a file  
xmlAddNs  — Add a namespace to a XML Element  
xmlAppend  — Append an element to the parent children  
xmlAsNumber  — Convert the result of a XPath query into a row of numbers  
xmlAsText  — Convert the result of a XPath query into a row of strings  
xmlDTD  — Create a XML DTD object  
xmlDelete  — Delete a XML document  
xmlDocument  — Create a new XML document  
xmlDump  — Dump a XML object  
xmlElement  — Create a new XML element  
xmlFormat  — Format a Scilab variable into XML  
xmlGetNsByHref  — Get a namespace by its href  
xmlGetNsByPrefix  — Get a namespace by prefix  
xmlGetOpenDocs  — Get all open XML documents or all open XML Validation files.  
xmlGetValues  — Parses and gets values of chosen tags attributes in a XML file  
xmlIsValidObject  — Test the existence of a XML object  
xmlName  — Retrieve the name of the elements.  
xmlNs  — Create a new XML Namespace  
xmlRead  — Read a XML stream from a local or distant file  
xmlReadStr  — Read a XML tree from a string  
xmlRelaxNG  — Create a XML Relax NG object  
xmlRemove  — Remove an element or a list of elements from their parents  
xmlSchema  — Create a XML Schema object  
xmlSetAttributes  — Set the attributes name and value.  
xmlSetValues  — Sets some attribute=value in an XML document for a given tag/XPath  
xmlValidate  — Validate a document in using a DTD, a Relax NG or a Schema.  
xmlWrite  — Write a XML document in a file  
xmlXPath  — Make a XPath query on a XML document  
HDF5 files 
h5is* tests 
h5isArray  — Check if the HDF5 object is an array  
h5isAttr  — Check if the HDF5 object is an attribute  
h5isCompound  — Check if the HDF5 object is a compound object  
h5isFile  — Check if the HDF5 object is a file  
h5isGroup  — Check if the HDF5 object is a group  
h5isRef  — Check if the HDF5 object is a reference object  
h5isSet  — Check if the HDF5 object is a dataset  
h5isSpace  — Check if the HDF5 object is a dataspace  
h5isType  — Check if the HDF5 object is a type  
h5isVlen  — Check if the HDF5 object is a variable length array  
h5attr  — Create an attribute  
h5close  — Close a HDF5 object  
h5cp  — Copy an object  
h5dataset  — Create a dataset and write the data  
h5dump  — Dump the content of an H5 object on the standard output stream  
h5exists  — Test the existence of named object  
h5flush  — Flush all the buffers associated with a file  
h5get  — Get a named object  
h5group  — Create a group  
h5label  — Label a dataset  
h5ln  — Link an object to another one  
h5ls  — List the content of an HDF5 object (group or dataset)  
h5mount  — Mount a file on a group  
h5mv  — Move an object  
H5 Objects  — Describe the properties of the different H5 objects  
h5open  — Open an HDF5 file  
h5read  — Read the data of HDF5 dataset  
h5readattr  — Read the data of an HDF5 attribute  
h5rm  — Remove elements from an HDF5 file  
h5umount  — Unmount a previously mounted file.  
h5write  — Create a dataset (if it does not exist) and write the data  
h5writeattr  — Write an attribute in a group or a dataset  
Files : Input/Output functions 
Directory 
chdir  — changes Scilab current directory  
createdir  — makes new directory  
dir  — gets file list  
isdir  — checks that a path points to an existing directory  
ls  — shows files  
mkdir  — makes a new directory  
pwd  — gets Scilab current directory  
removedir  — removes a directory  
rmdir  — removes a directory  
file_system 
copyfile  — copies a file  
deletefile  — deletes a file  
fileinfo  — provide information about some files of any type  
findfiles  — finding all files with a given file specification  
isfile  — checks whether argument is an existing file  
listfiles  — list of files  
mdelete  — deletes file(s)  
movefile  — moves file or directory  
newest  — returns newest file of a set of files  
Paths - Filenames 
basename  — strip directory and suffix from filenames  
fileext  — returns extension for a file path  
fileparts  — returns the path, filename and extension for a file path  
filesep  — returns directory separator for current platform  
fullfile  — builds a full filename from parts  
fullpath  — creates an full path name for the specified relative path name.  
get_absolute_file_path  — gives an absolute pathname of a file opened in Scilab  
getdrives  — gets the drive letters of all mounted filesystems on the computer  
getlongpathname  — gets long path name  
getrelativefilename  — given absolute directories and absolute filenames, returns relative file names  
getshortpathname  — gets short path name  
is_absolute_path  — checks if argument is an absolute path  
pathconvert  — converts a path to an OS path format.  
pathsep  — provides the path separator used in the PATH environment variable of the current OS.  
tempname  — creates a file with an unique filename  
compress  — Compress files in an archive  
decompress  — decompress files from an archive  
dispfiles  — displays properties of opened files  
fprintfMat  — writes a matrix in a file  
fscanfMat  — reads a matrix from a text file  
getdeprecated  — Get names of deprecated functions and replacement function names.  
getmd5  — get md5 checksum  
hash  — get checksum of file or string using various digest algorithms  
%io  — protected variable providing ids of the standard input and standard output  
listvarinfile  — lists variables stored in a binary archive (names, types, sizes..)  
mclearerr  — resets binary file access errors  
mclose  — closes opened files  
meof  — checks 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 input from the stream pointer stream (interface to the C
            fscanf function)  
mget  — parses numbers in a binary file and returns them as decimals  
mgetl  — reads lines from an text file  
mgetstr  — reads a character string from a file  
mopen  — opens files in Scilab  
mput  — writes  byte or word in a given binary format  
mputl  — writes strings in a text file  
mputstr  — write a single text in an open file  
mseek  — sets current position in a binary file  
mtell  — Returns the offset of the current byte relative to the beginning of a file  
save format  — format of files produced by "save"  
scanf  — converts formatted input on standard input  
scanf_conversion  — mscanf, msscanf, mfscanf conversion specifications  
Input/Output functions 
OS_commands 
getenv  — get the value of an environment variable  
getpid  — get Scilab process identificator  
host  — executes a Windows, Linux, or MacOS command  
 scilab  — run command or file in another Scilab  
setenv  — set the value of an environment
            variable  
unix_g  — executes some Windows, Linux or MacOS instructions: output in variables
          This function is obsolete. Please use host  instead.   
unix_s  — executes some Windows, Linux or MacOS instructions: output canceled (Silent mode)
        This function is obsolete. Please use host  instead.   
unix_w  — executes some Windows, Linux or MacOS instructions: output in Scilab's console
        This function is obsolete. Please use host  instead.   
unix_x  — executes some Windows, Linux or MacOS instructions: output in a dedicated window
        This function is obsolete. Please use host  instead.   
file  — file management  
getio  — get Scilab input/output logical units  
load  — Loads some archived variables, a saved graphic figure, a library of functions  
read  — matrices read  
save  — Saves some chosen variables in a binary data file  
write  — writes real numbers or strings in the console or in a formatted file  
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  — plots as arrows a field of 2D vectors  
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  
contour2dm  — compute level curves of a surface defined with a mesh  
contourf  — filled level curves of a surface on a 2D plot  
cutaxes  — plots curves or an existing axes along a discontinuous or multiscaled axis  
errbar  — add vertical error bars on a 2D plot  
fchamp  — direction field of a 2D first order ODE  
fec  — pseudo-color plot of a function defined on a mesh  
fec properties  — description of the fec entities
            properties  
fgrayplot  — 2D plot of a surface defined by a function using colors  
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  
loglog  — 2D logarithmic plot  
paramfplot2d  — animated plot of a 2D parametrized curve.  
plot  — 2D plot  
plot2d  — 2D plot  
plot2d2  — 2D plot (step
            function)  
plot2d3  — 2D plot (vertical
            bars)  
plot2d4  — 2D plot (arrows style)  
plotimplicit  — Plots the (x,y) lines solving an implicit equation or Function(x,y)=0  
polarplot  — Plot polar
            coordinates  
scatter  — 2D scatter plot  
semilogx  — 2D semilogarithmic plot  
semilogy  — 2D semilogarithmic plot  
stackedplot  — plot multiple timeseries on time axis  
3d_plot 
bar3d  — 3D bars plot  
comet3d  — 3D comet animated plot  
contour  — level curves on a 3D surface  
cylinder  — Computes cylinder coordinates  
eval3dp  — compute facets of a 3D parametric surface  
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  
mesh  — 3D mesh plot  
nf3d  — Rectangular facets to plot3d parameters  
param3d  — plots a single curve in a 3D cartesian frame  
param3d properties  — description of the 3D curves
            entities properties  
peaks  — Computes values of a function with lots of local maxima and minima.  
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  
scatter3d  — 3D scatter plot  
secto3d  — 3D surfaces conversion  
sphere  — Computes sphere coordinates  
surf  — 3D surface plot  
surface properties  — description of the 3D entities
            properties  
annotation 
Label entity properties  — Properties of Axes labels and title  
legend  — draw graph legend  
Legend entity properties  — description of the Legend entity properties.  
legends  — draw graph legend  
title  — displays a title above a graphic axes, or updates its properties.  
xlabel  — sets or updates the x-axis label or/and its properties  
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.  
isoview  — tunes isometric rendering of graphical axes  
newaxes  — Creates a new Axes entity  
replot  — reframes with new boundaries the current or a given set of axes  
rotate_axes  — Interactive rotation of an Axes handle.  
sca  — set the current axes entity  
sda  — reSets the Default Axes to its factory values  
subplot  — grids the current figure or frame, and sets the current axes to a chosen cell  
unzoom  — unzoom graphics  
xgrid  — add a grid on a 2D or 3D plot  
xsetech  — set the sub-window of a graphics window for plotting  
zoom_rect  — zoom a selection of the current graphic figure  
axis 
axis properties  — description of the axis entity
            properties  
drawaxis  — draw an axis  
graduate  — Pretty axis graduations  
xgraduate  — axis graduation  
bar_histogram 
bar  — bar histogram  
barh  — horizontal display of bar histogram  
barhomogenize  — homogenize all the bars included in the current working axes  
Color management 
Colormaps 
colormap  — set and/or get a figure/axes colormap.  
Using colormaps  — Using colormaps in graphics.  
Predefined colormaps  — Overview of predefined colormaps.  
addcolor  — add new colors to the current colormap  
color  — returns the color id of a color  
color_list  — list of named colors  
colorbar  — draws a vertical color bar  
getcolor  — opens a dialog to show colors of the current or default colormap  
hsv2rgb  — Converts HSV colors to RGB  
name2rgb  — returns the RGB values of a named color  
rgb2name  — returns the name of a color  
uigetcolor  — Opens a dialog for selecting a color.  
Datatips 
datatipCreate  — Create a datatip on a polyline by program  
datatipGetEntities  — Get all the entities compatible with datatips in the given axes.  
datatipManagerMode  — Set or toggles the datatips mode.  
datatipMove  — Move a specified datatip using the mouse.  
datatipRemove  — Removes a selected datatip  
datatipRemoveAll  — Removes all datatips on a set of polylines.  
datatipSetDisplay  — Set the function used to compute the datatip string.  
datatipSetInterp  — Set the interpolation mode for datatip.  
datatipSetOrientation  — Set the position of the text box associated with the given tip.  
datatipSetStyle  — Set the datatip style.  
datatip properties  — description of the Datatip
            entity properties  
datatips  — Tool for placing and editing tips along the plotted curves  
figure_operations 
anti_aliasing  — Figure's property smoothing the stair-like aspect when rendering curves  
clf  — Clears and resets a figure or a frame uicontrol  
colordef  — Set the color look-and-feel of a given or of all forthcoming graphic figures  
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.  
pixel_drawing_mode  — Figure's property setting the RGBwise pixels update mode when drawing  
scf  — set the current graphic figure
            (window)  
sdf  — reSets the properties of the Default Figure to their factory values  
show_window  — raises a graphics window  
winsid  — return the list of graphics windows  
geometric_shapes 
arc properties  — description of the Arc entity properties  
rectangle properties  — description of the Rectangle
            entity properties  
Segments properties  — description of the Segments entity properties  
xarc  — draw a part of an ellipse  
xarcs  — draw parts of a set of ellipses  
xarrows  — draw a set of arrows in 2D or in 3D.  
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  
xsegs  — draw unconnected segments  
handle 
copy  — copy a graphics entity.  
delete  — delete  a graphic entity and its children.  
gce  — Get current entity handle.  
ged  — Scilab Graphic Editor  
glue  — glue a set of graphics entities into an Compound.  
is_handle_valid  — Check whether a set of graphic handles is still valid.  
swap_handles  — Permute two handles in the graphic
            Hierarchy.  
unglue  — unglue a compound object and replace it by individual children.  
interaction 
dragrect  — Drag rectangle(s) with mouse  
edit_curv  — interactive modal (blocking) graphic curve editor  
event handler functions  — Prototype of functions which may be used as event handler.  
locate  — mouse selection of a set of points in a 2D axes  
rubberbox  — rubberband box for rectangle selection  
seteventhandler  — set an event handler for
            the current graphic window  
twinkle  — highlights one or more graphical objects by flashing them  
xclick  — Wait for a mouse click or an event in a graphic window.  
xgetmouse  — get the mouse events and current position  
lighting 
light  — creates a light object in the given axes  
light properties  — Light overview  
lighting  — Lighting overview  
load_save 
xload  — displays in a given window some graphical component loaded from a file.  
xsave  — save graphics into a
            file  
polygon 
polyline properties  — description of the Polyline
            entity properties  
xfpoly  — fill a polygon  
xfpolys  — fill a set of polygons  
xpoly  — draw a polyline or a
            polygon  
xpolys  — draw a set of polylines or polygons  
xrpoly  — draw a regular polygon  
property 
get  — Gets the handle of a graphical or User Interface object, or the property's value of objects.  
set  — set properties of some graphic objects or uimenus or uicontrol interactive components  
text 
graphics fonts  — description of fonts used in graphic figures  
Math rendering in Scilab graphics  — 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  
xlfont  — load a font in the graphic context or query loaded
            font  
xnumb  — draw numbers  
xstring  — draw strings  
xstringb  — draw strings into a box  
xstringl  — compute a box which surrounds
            strings  
transform 
move  — move, translate, a graphic entity and its children.  
orthProj  — Computes the orthogonal projection of a point to a polyline in the plane.  
rotate  — rotation of a set of points  
scaling  — affine transformation of a set of points  
GlobalProperty  — customizes the objects appearance (curves, surfaces...) in a plot or surf command  
Graphics: Getting started  — graphics library overview  
Compound properties  — description of the Compound entity properties  
Graphics Entities  — description of the graphics entities data structures  
graphical editor  — Interactive edition of hierarchical properties of graphic objects  
pie  — draw a pie  
multiscaled plots  — How to set several axes for one curve or for curves with distinct scales  
xchange  — transform real to pixel coordinates  
Graphics export 
driver  — select a graphics driver  
xend  — close a graphics export session  
xinit  — open a graphics export session  
xs2bmp  — export graphics to BMP  
xs2emf  — export graphics to EMF.  
xs2eps  — export graphics to EPS  
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 
 
Data Structures 
cells 
cell  — creates a cell array of empty matrices  
cell2mat  — converts a cell array into a matrix  
iscell  — checks if a variable is a cell array  
makecell  — Creates a cell array.  
num2cell  — converts an array into a cell array  
bool2s  — convert boolean matrix to a zero one matrix.  
definedfields  — returns an index of list's defined fields  
fieldnames  — get a tlist, mlist or struct fields names  
getfield  — list field extraction  
isfield  — checks if the given fieldname exists in a structure or mlist or tlist  
isstruct  — checks if a variable is a structure array  
list  — a Scilab object and a list definition function  
list2vec  — Concatenates list entries in a matrix.  
lstcat  — list concatenation  
mlist  — Scilab object, matrix oriented typed list
            definition  
null  — deletes a list component or a field of a structure, Mlist, or Tlist  
rlist  — Scilab rational fraction function definition  
rmfield  — Remove fields from a struct  
setfield  — change the value of an element of a mlist, tlist or list  
struct  — Builds a structure or an array of structures  
tlist  — Scilab object and typed list definition.  
tree_show  — Displays a tree view of a list, tlist, mlist, cell or structure array, Xcos block  
vec2list  — Inverse function of list2vec.  
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  
Strings 
ascii  — string ASCII conversions  
blanks  — create string of blank characters  
char  — converts in a character array  
convstr  — case conversion  
emptystr  — zero length string  
evstr  — evaluates Scilab expressions and concatenates their results  
grep  — find matches of a string in a vector of strings  
isalphanum  — check that characters of a string are alphanumerics  
isascii  — Tests if every character of given strings is 7-bit US-ASCII  
isdigit  — check that characters of a string are digits between 0 and 9  
isletter  — check that characters of a string are alphabetic letters  
isnum  — tests if a string represents a number  
justify  — Aligns the strings completed with spaces within each column, to the left, center or right  
length  — Number of characters of a string. Number of elements of an array or list.  
part  — Extraction of characters from strings  
prettyprint  — Converts a Scilab object into some corresponding LaTeX, TeX, MathML or HTML strings  
regexp  — in a string, locate (and extract) substrings matching a regular expression  
sci2exp  — returns a string able to generate a given Scilab object  
strcat  — concatenates character strings  
strchr  — find the first occurrence of a character in a string  
strcmp  — compare character strings  
strcspn  — lengths from the beginning of strings until a character among those prohibited  
strindex  — search position of a character string in another string  
string  — conversion to character string  
stripblanks  — strips / trims leading or trailing or both
            blanks (and tabs) of strings  
strncpy  — copy the N first characters of the given strings  
strrchr  — find the last occurrence of a character in a string  
strrev  — Reverses the order of characters in the given strings  
strsplit  — split a single string at some given positions or patterns  
strspn  — lengths of the beginning of strings as long as characters are among those allowed  
strstr  — Tail of a string starting from the 1st occurrrence of a given fragment  
strsubst  — substitute a character string by another in a character string  
strtod  — parse and convert literal numbers STRings TO Decimal numbers  
strtok  — split string into tokens  
tokenpos  — returns the tokens positions in a character string  
tokens  — Splits a string using separators and gives its chunks  
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  — Computes and displays an Amplitude(time, frequency) spectrogram of a sound record  
mu2lin  — mu-law encoding to linear signal  
playsnd  — command-line sound player facility  
savewave  — save data into a sound wav file.  
wavread  — reads sound data or querries data info from a .wav audio file  
wavwrite  — writes .wav sound file  
Time and Date 
caldays  — create a calendarDuration in days  
calendar  — Calendar of a given month and year (Gregorian dates)  
calendarDuration  — create a calendarDuration - duration in days, months and years  
clock  — Return the current Gregorian datetime and international time zone of the computer's clock  
date  — Current date as date string  
datenum  — Convert to serial date number  
datetime  — create points in time  
datevec  — Date components  
 day  — extracts day from datetime  
duration  — create a duration - duration in hours, minutes and seconds  
eomday  — Return last day of month  
etime  — Elapsed time  
getdate  — Current datetime or POSIX timestamp from computer's clock. Datetimes from given timestamps  
 hms  — extracts hour, minute and second of datetime or duration  
hours  — convert reals in hours (duration) / convert hours (duration) in reals  
 isnat  — check if a variable contains "Not a Time" values  
 month  — extracts month from datetime  
NaT  — Not a Time function used to create empty datetime  
now  — Return current date under the form of a Unix hour (timestamp)  
realtimeinit  — sets the time unit  
sleep  — suspend all code executions (console, scripts, callbacks,..)  
tic  — start a stopwatch timer  
timer  — cpu time  
toc  — Read the stopwatch timer  
weekday  — Day's index and name in its week for given dates  
 year  — extracts year from datetime  
 ymd  — extracts year, month and day of datetime  
Output functions 
disp  — displays variables  
mprintf  — converts, formats, and writes data to the main scilab window  
msprintf  — converts, formats, and writes data in a string  
print  — prints variables  in a file  
printf_conversion  — mprintf, msprintf, mfprintf C-format specifications  
Xcos 
 
Spreadsheet 
 
Console 
ans  — answer  
clc  — Clear Command Window  
completion  — returns files or variables names or reserved keywords starting as a given text  
console  — Keyboard shortcuts predefined in the console window  
diary  — diary of session  
input  — prompts the user for keyboard input  
lines  — sets and queries the display width and pagination for the console  
mode  — sets or queries the mode echoing Scilab instructions in the console  
%onprompt  — special custom function called after each line execution in console  
prompt  — Get/Set current prompt  
tohome  — Clears the command window by masking its former content above the top  
History manager 
 
Matlab data files I/O 
 
Code Matlab => Scilab 
 
MEX Library API 
 
Advanced functions 
Built-in & external 
clearfun  — removes primitive  
external  — Scilab Object, external function or routine  
funptr  — coding of  primitives ( wizard stuff )  
intppty  — set interface argument passing properties  
newfun  — add a name in the table of functions  
what  — list the Scilab
            primitives  
Libraries 
genlib  — builds a library from a set of *.sci files defining functions in a given directory  
get_function_path  — get source file path of a library function  
lib  — loads a library of Scilab functions and variables, and sets its name  
librarieslist  — gets the list of loaded Scilab libraries  
libraryinfo  — gets the path and the set of primary functions of a loaded library  
argn  — Returns the actual number of input/output arguments in a function call  
deff  — in-line definition of a (anonymous) function in Scilab language  
exec  — script file execution  
execstr  — execute Scilab code in strings  
feval  — multiple evaluation  
funcprot  — switch scilab functions protection mode  
function  — opens a function definition  
getd  — Load all functions defined in a directory  
macr2tree  — provides the internal code of a compiled Scilab function  
macro  — Scilab procedure and Scilab object  
macrovar  — variables of function  
overloading  — display, functions and operators overloading
            capabilities  
tree2code  — generates the text definition of a Scilab function from its internal code  
varargin  — variable number of arguments in an input argument list  
varargout  — arbitrarily long list of output arguments  
whereis  — Returns the name of the loaded library/module a given function belongs to  
Testing & benchmarking 
 
Demo Tools 
add_demo  — Add an entry in the demos list  
demo_begin  — begin a demonstration. This function is obsolete. Please use exec instead.   
demo_choose  — create a dialog box for the choice of options. This function is obsolete. Please use x_choose instead.   
demo_compiler  — test the presence of a compiler. This function is obsolete. Please use haveacompiler instead.   
demo_end  — completes a demonstration. This function is obsolete. Please use exec instead.   
demo_file_choice  — choose and executes an item within a list. This function is obsolete. Please use x_choose instead.   
demo_function_choice  — choose and execute an item within a list. This function is obsolete. Please use x_choose instead.   
demo_run  — script file execution. This function is obsolete. Please use exec instead.   
Dynamic/incremental Link 
G_make  — call make or nmake  
addinter  — new functions interface dynamic link at run time.  
c_link  — check if symbol loaded with dynamic link  
call  — Fortran or C user routines call  
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  
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_build_jar  — Build Java packages from sources into a JAR file  
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 formatted 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 and compatible compilers  — supported and compatible compilers by Scilab  
ulink  — unlink/unload a dynamically linked shared object  
Windows tools 
consolebox  — shows or hides the MS Windows terminal running the Scilab session  
createGUID  — Creates a GUID (Windows only)  
dos  — executes some DOS instructions (Windows only)
        This function is obsolete. Please use host  instead.   
findfileassociation  — Searches for and retrieves a file association-related string from the registry (Windows only)  
getsystemmetrics  — Retrieves the specified system metric or system configuration
            setting (Windows only)  
istssession  — Determines if scilab is launched from a ms terminal service session (Windows only)  
mcisendstring  — sends a command string to an MCI
            device (Windows only)  
powershell  — executes a command with the Windows powershell interpreter (Windows only)  
win64  — Determine whether Windows x64 version of Scilab (Windows only)  
winopen  — Open file in appropriate application
            (Windows only)  
winqueryreg  — Get item from Microsoft Windows
            registry (Windows only)  
ATOMS 
 
Tcl/Tk Interface 
 
Script editor 
edit  — edits a given Scilab function or file  
edit_error  — opens in scilab editor the source of the last recorded error  
editor  — Call the text editor as defined in the preferences  
scinotes  — Scinotes: Embedded Scilab text editor  
UI Data 
 
Documentation system 
utilities 
add_help_chapter  — Add an entry in the help list  
del_help_chapter  — Delete an entry in the help list  
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  
Link toolbox help with Scilab one  — How to make hyperlink in toolbox help pointing to Scilab's items  
Scilab documentation format  — on line help XML file description format  
manedit  — editing a manual item  
%helps  — global variable: paths to help directories of loaded external modules  
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  
apropos  — searches keywords in Scilab help  
doc  — queries and displays help pages in the Scilab help browser  
head_comments  — display Scilab function header comments  
Modules manager 
 
Scilab MPI 
MPI_Bcast  — Broadcasts a message from the process with rank root to all other processes of the group  
MPI_Comm_rank  — Determines the rank of a calling process in a communicator  
MPI_Comm_size  — Determines the size of the group associated with a communicator  
MPI_Create_comm  — Create a MPI subcommunicator of MPI_COMM_WORLD  
MPI_Finalize  — Terminate the MPI environment  
MPI_Init  — Initialize the MPI environment  
MPI_Irecv  — Nonblocking reception of data from a node  
MPI_Isend  — Nonblocking send data from a node to another  
MPI_Recv  — Recv data from a node  
MPI_Send  — Send data from a node to another  
MPI_Wait  — Waits for an MPI request to complete  
MPI  — Access to MPI features from Scilab  
MPI implementation  — Technical details about the implementation  
Multilinguism 
addlocalizationdomain  — add a new domain in localization mechanism.  
getdefaultlanguage  — returns the default language used by Scilab  
getlanguage  — returns the current language used by Scilab.  
gettext  — indexes or/and translates some indexed english messages  
setdefaultlanguage  — sets the language of the session at startup and for some fixed Scilab menus  
setlanguage  — chooses the language used for standard messages and help pages for the current session  
API Scilab 
API Scilab  — api_scilab is the Scilab 6 interface to access Scilab variables.  
Getting started with API_Scilab  — How to load a C, C++ or fortran code in the Scilab engine as a new function  
API common functions  — This page lists all the functions to get information about Scilab native objects.  
API double functions  — This page lists all the functions to manipulate Scilab native objects containing doubles.  
API string functions  — This page lists all the functions to manipulate Scilab native objects containing strings  
API boolean functions  — This page lists all the functions to manipulate Scilab native objects containing booleans  
API integer functions  — This page lists all the functions to manipulate Scilab native objects containing integers  
API list-type functions  — This page lists all the functions to manipulate Scilab native lists.  
API polynomial functions  — This page lists all the functions to manipulate Scilab native objects containing polynomials  
API pointer functions  — This page lists all the functions to manipulate Scilab native objects containing pointers  
API cell functions  — This page lists all the functions to manipulate Cell objects.  
API struct functions  — This page lists all the functions to manipulate functions to manipulate Struct objects.  
API handle functions  — This page lists all the functions to manipulate Scilab native objects containing graphic handles  
API optional functions  — This page lists all the functions to get information about optional parameters.  
API types  — This page lists all types used by API Scilab.  
call_scilab API (Scilab engine) 
DisableInteractiveMode  — Disables some features (plotting, gui creation, Tcl/Tk...) and
            leaves only the computing engine  
ExecScilabCommand  — Execute a Scilab from a C/C++ code (call_scilab) and can get message and callstack on error.  
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  
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 with Call Scilab  — How to compile a native application based on or using
            Scilab  
fromc  — Checks if current Scilab is called from an external C program (by StartScilab).  
fromjava  — Checks if current Scilab is called from javasci  
Java Virtual Machine (JVM) 
 
Java from Scilab 
Getting started - Beginning  — How to use the Java Scilab binding?  
Getting started - Second step  — How to use the Java Scilab binding?  
jallowClassReloading  — Allow the class reloading  
jarray  — Create a Java array  
jautoTranspose  — Set the way to convert matrices  
jautoUnwrap  — Unwrap automatically returned values  
jcast  — Cast a Java object into another one.  
jcompile  — Compile Java code or file  
jcreatejar  — Creates a Java ARchive (JAR) from a set of files / directories  
jdeff  — Map a static Java method onto a Scilab macro  
jdisableTrace  — Stop the trace process.  
jenableTrace  — Allow to trace the internal functionality of JIMS to help the debugging.  
jexists  — Test if a Scilab Java Object is valid on the Java side  
jgetclassname  — Return the class name of the given object  
jgetfield  — Get the field value of a Java object  
jgetfields  — Get all the fields of a Java object  
jgetinfo  — Returns information about the Java virtual machine  
jgetmethods  — Get all the methods of a Java object  
jimport  — Import a Java class  
jinvoke  — Invoke a method of a Java object  
jinvoke_db  — Invoke a method of a Java object in using Java direct buffers  
jnewInstance  — Creates a new instance of a Java class  
jnull  — The Scilab version of the Java null object.  
jremove  — Remove a Java Object on the Java side  
jsetfield  — Set the field of a Java object  
junwrap  — Convert a Java object into a Scilab native type  
junwraprem  — Convert a Java object into a Scilab native type and remove it from the Java side  
jvoid  — For no argument functions  
jwrap  — Wrap a Scilab variable into a Java one if possible  
jwrapinchar  — Wrap Scilab uint16 matrix into Java char multiarray.  
jwrapinfloat  — Wrap Scilab double matrix into Java float multiarray.  
new  — Creates a new instance of a Java class  
Java Interface 
 
Preferences 
 
Scilab code instrumentation 
covMerge  — Merges coverage results and exports to a file  
covStart  — Instruments some macros to store runtime information on code coverage and
            execution time  
covStop  — Removes all instrumentation data  
covWrite  — Exports runtime performance results to HTML and binary files  
profile  — General information about instrumentation capabilities  
profileDisable  — Remove instrumentation from a function, a library or remove all instrumentation  
profileEnable  — Add instrumentation to a function, a library or all available functions  
profileGetInfo  — Retrieve instrumentation information as a Scilab value  
Lint tool (SLint) 
 
Web Tools