Scilab 5.5.2
Scilab Help
- Scilab
- Scilab keywords
- ans — answer
- backslash — (\) left matrix division.
- brackets — ([,]) left and right brackets
- colon — (:) colon operator
- comma — (,) comma; instruction, argument separator
- comments — (//) comments
- comparison — comparison, relational operators
- dollar — ($) last index
- dot — (.) symbol
- else — keyword in if-then-else and select-case-then-else
- elseif — keyword in if-then-else
- empty — ([]) empty matrix
- end — end keyword
- equal — (=) assignment , comparison, equal sign
- extraction — matrix and list entry extraction
- global — Define global variable
- hat — (^) exponentiation
- assignation — partial variable assignation
- great — (>) greater than comparison
- minus — (-) subtraction operator, sign changes
- not — (~) logical not
- parentheses — ( ) left and right parenthesis
- percent — (%) special character
- plus — (+) addition operator
- power — (^,.^) power operation
- quote — (') transpose operator, string delimiter
- semicolon — (;) ending expression and row separator
- slash — (/) right division and feed back
- star — (*) multiplication operator
- symbols — scilab operator names
- tilde — (~) logical not
- catch — beginning of catch block in try-catch control instruction
- Control flow
- abort — interrupt evaluation.
- 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
- for — language keyword for loops
- if — keyword for conditional execution
- pause — pause mode, invoke keyboard
- 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'
- while — while keyword
- Configuration
- banner — shows Scilab banner
- getdebuginfo — get information about Scilab to debug
- 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.
- getversion — get scilab and modules version information
- gstacksize — set/get scilab global stack size
- stacksize — set scilab stack size
- 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
- with_tk — Checks if Scilab has been built with TCL/TK
- Debugging
- Error handling
- Variables
- Predefined variables
- SCI — 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.
- %e — Euler number.
- %eps — epsilon (floating-point relative accuracy)
- %f or %F — Boolean variable for false.
- %i — 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.
- clear — kills variables
- clearglobal — kills global variables
- exists — checks variable existence
- getvariablesonstack — get variable names on stack of scilab
- isdef — checks variable existence
- isglobal — check if a variable is global
- names — Scilab names syntax
- predef — variable protection
- who — listing of variables
- who_user — listing of user's variables
- whos — listing of variables in long form
- Predefined variables
- exit — Ends the current Scilab session
- perl — Call Perl script using appropriate operating system executable. This function is obsolete.
- quit — Terminates Scilab or decreases the pause level
- scilab — Main script to start Scilab and miscellaneous tools (GNU/Linux, Unix and Mac OS X)
- startup — startup files
- Scilab keywords
- Differential calculus, Integration
- bvodeS — Simplified call to bvode
- dae — Differential algebraic equations solver
- daeoptions — set options for dae solver
- daskr — DAE solver with zero crossing
- dasrt — DAE solver with zero crossing
- dassl — differential algebraic equation
- diff — Difference and discrete derivative
- 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
- intsplin — integration of experimental data by spline interpolation
- inttrap — integration of experimental data by trapezoidal interpolation
- numdiff — numerical gradient estimation at one point. This function is obsolete. Please use the numderivative function instead.
- 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 numbers
- squarewave — generates a square wave with period 2*%pi
- sub2ind — matrix subscript values to linear index
- testmatrix — generate special matrices, such as Hilbert, Franck
- toeplitz — Toeplitz matrix
- zeros — matrix made of zeros
- 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
- logm — square matrix logarithm
- polar — polar form
- sqrt — square root
- sqrtm — matrix square root
- Floating point
- ceil — round up
- clean — cleans matrices (round to zero small entries)
- double — conversion from integer to double precision representation
- fix — round towards zero
- floor — round down
- format — number printing and display format
- frexp — dissect floating-point numbers into base 2 exponent and mantissa
- ieee — set floating point exception mode
- 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
- 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
- Matrix manipulation
- flipdim — flip x block components along a given dimension
- matrix — reshape a vector or a matrix to a different size matrix
- permute — permute the dimensions of an array
- pertrans — Transposition with reference to the 2nd diagonal
- repmat — Replicate and tile an array
- resize_matrix — trim or/and extend (and cast) a matrix or hypermatrix
- squeeze — removes singleton dimensions of a hypermatrix
- Matrix operations
- abs — absolute value, magnitude
- cross — vector cross product
- cumprod — cumulative product of array elements
- cumsum — cumulative sum of array elements
- kron — Kronecker product (.*.)
- max — maximum
- min — minimum
- norm — matrix norm
- prod — product of array elements
- signm — matrix signum function
- sum — sum of array elements
- tril — lower triangular part of matrix
- triu — upper triangle
- Search and sort
- dsearch — distribute, locate and count elements of a matrix or hypermatrix in given categories
- find — find indices of boolean vector or matrix true elements
- gsort — sorting by quick sort algorithm
- lex_sort — lexicographic matrix rows sorting
- vectorfind — finds in a matrix rows or columns matching a vector
- Set operations
- intersect — returns the vector of common values of two vectors
- members — count (and locate) in an array each element or row or column of another array
- setdiff — returns components of a vector which do not belong to another one
- union — extract union components of a vector
- unique — extract unique components of a vector or matrices
- Signal processing
- bloc2exp — Conversion of a block-diagram to its symbolic expression
- bloc2ss — block-diagram to state-space conversion
- pen2ea — pencil to E,A conversion
- ssrand — random system generator
- sysconv — system conversion
- sysdiag — Create a block diagonal matrix from provided inputs or block diagonal system connection
- trfmod — poles and zeros display
- Symbolic
- addf — symbolic addition
- cmb_lin — symbolic linear combination
- ldivf — left symbolic division
- mulf — symbolic multiplication
- rdivf — right symbolic division
- solve — symbolic linear system solver
- subf — symbolic subtraction
- trianfml — symbolic triangularization
- trisolve — symbolic linear system solver
- 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
- cos — cosine function
- cosd — element-wise cosine function, argument in degree
- cosh — hyperbolic cosine
- coshm — matrix hyperbolic cosine
- cosm — matrix cosine function
- cotd — element-wise cotangent function, argument in degree
- cotg — cotangent
- coth — hyperbolic cotangent
- cothm — matrix 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.
- csgn — returns the sign of a vector of real of complex values
- 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
- 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
- and — logical AND of the elements of an array
- & — logical AND operator
- cat — concatenate several arrays
- cell2mat — converts a cell array into a matrix
- cellstr — converts strings vector (or strings matrix) into a cell array of strings
- iscolumn — check if a variable is a column
- isempty — check if a variable is an empty matrix or an empty list
- isequal — objects comparison
- ismatrix — check if a variable is a matrix
- 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
- lstsize — list, tlist, mlist numbers of entries
- pmodulo — positive euclidian remainder modulo m
- ndims — number of dimensions of an array
- nthroot — Real nth root of real numbers
- num2cell — converts an array into a cell array
- or — logical OR of the elements of an array
- | — logical OR operator
- sign — signum function
- size — size of objects
- unwrap — unwrap a Y(x) profile or a Z(x,y) surface. Unfold a Y(x) profile
- Linear Algebra
- Eigenvalue and Singular Value
- balanc — matrix or pencil balancing
- bdiag — block diagonalization, generalized eigenvectors
- gschur — generalized Schur form. This function is obsolete.
- gspec — eigenvalues of matrix pencil. This function is obsolete.
- hess — Hessenberg form
- pbig — eigen-projection
- projspec — spectral operators
- psmall — spectral projection
- schur — [ordered] Schur decomposition of matrix and pencils
- spec — eigenvalues of matrices and pencils
- sva — singular value approximation
- svd — singular value decomposition
- Factorization
- givens — Givens transformation
- householder — Householder orthogonal reflexion matrix
- sqroot — W*W' hermitian factorization
- Kernel
- Linear Equations
- 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
- Matrix Pencil
- companion — companion matrix
- 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
- pencan — canonical form of matrix pencil
- penlaur — Laurent coefficients of matrix pencil
- quaskro — quasi-Kronecker form
- randpencil — random pencil
- rowshuff — shuffle algorithm
- sylv — Sylvester equation.
- State-Space Matrices
- Subspaces
- proj — projection
- Eigenvalue and Singular Value
- 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
- 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 (Computer Aided Control Systems Design)
- Formal representations and conversions
- abcd — state-space matrices
- cont_frm — transfer to controllable state-space
- dbphi — frequency response to phase and magnitude representation
- 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
- 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
- tf2des — transfer function to descriptor
- tf2ss — transfer to state-space
- Plot and display
- black — Black-Nichols diagram of a linear dynamical system
- bode — Bode plot
- bode_asymp — Bode plot asymptote
- evans — Evans root locus
- gainplot — magnitude plot
- hallchart — Draws the Hall chart
- m_circle — plots the complex plane iso-gain contours of y/(1+y) (obsolete)
- nicholschart — Nichols chart
- nyquist — nyquist plot
- phaseplot — frequency phase plot
- sgrid — s-plane grid lines.
- show_margins — display gain and phase margin and associated crossover frequencies
- svplot — singular-value sigma-plot
- zgrid — zgrid plot
- 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
- arma2ss — transform an armax data structure into state space 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
- bstap — hankel approximant
- cainv — Dual of abinv
- calfrq — frequency response discretization
- canon — canonical controllable form
- ccontrg — Central H-infinity continuous time controller
- cls2dls — bilinear transform
- colinout — inner-outer factorization
- colregul — removing poles and zeros at infinity
- cont_mat — controllability matrix
- contr — controllability, controllable subspace, staircase
- contrss — controllable part
- copfac — right coprime factorization of continuous time dynamical systems
- csim — simulation (time response) of linear system
- ctr_gram — controllability gramian
- damp — Natural frequencies and damping factors.
- dcf — double coprime factorization
- ddp — disturbance decoupling
- 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 — Continuous time dynamical systems stable anti-stable decomposition
- equil — balancing of pair of symmetric matrices
- equil1 — balancing (nonnegative) pair of matrices
- 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
- freq — frequency response
- freson — peak frequencies
- fspec — spectral factorization of continuous time dynamical systems
- fspecg — stable factorization of continuous time dynamical systems
- fstabst — Youla's parametrization of continuous time linear dynmaical systems
- g_margin — gain margin and associated crossover frequency
- gamitg — H-infinity gamma iterations for continuous time systems
- gcare — Continuous time control Riccati equation
- gfare — Continuous time filter Riccati equation
- gfrancis — Francis equations for tracking
- gtild — tilde operation
- 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
- 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 — Continuous time dynamical systems 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)
- macglov — Continuous time dynamical systems Mac Farlane Glover problem
- minreal — minimal balanced realization
- minss — minimal realization
- mucomp — mu (structured singular value) calculation
- narsimul — armax simulation (using rtitr)
- nehari — Nehari approximant of continuous time dynamical systems
- noisegen — noise generation
- 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
- plzr — pole-zero plot
- pol2des — polynomial matrix to descriptor form
- ppol — pole placement
- prbs_a — pseudo random binary sequences generation
- projsl — linear system projection
- 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
- sident — discrete-time state-space realization and Kalman gain
- sorder — computing the order of a discrete-time system
- specfact — spectral factor
- ssprint — pretty print for linear system
- st_ility — stabilizability test
- stabil — stabilization
- sysfact — system factorization
- syslin — linear system definition
- syssize — size of state-space system
- time_id — SISO least square identification
- trzeros — transmission zeros and normal rank
- ui_observer — unknown input observer
- unobs — unobservable subspace
- zeropen — zero pencil
- Formal representations and conversions
- Polynomials
- bezout — Bezout equation for polynomials or integers
- chepol — Chebychev polynomial
- 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
- hermit — Hermite form
- horner — polynomial/rational evaluation
- hrmt — gcd of polynomials
- htrianr — triangularization of polynomial matrix
- inv_coeff — build a polynomial matrix from its coefficients
- invr — inversion of (rational) matrix
- lcmdiag — least common multiple diagonal factorization
- ldiv — polynomial matrix long division
- numer — numerator
- pdiv — polynomial division
- pol2str — polynomial to string conversion
- polfact — minimal factors
- poly — polynomial definition
- rational — Scilab objects, rational in Scilab
- 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
- varn — symbolic variable of a polynomial or a rational
- Signal Processing
- filters
- analpf — create analog low-pass filter
- buttmag — Power transmission of a Butterworth filter
- casc — cascade realization of filter from coefficients
- cheb1mag — response of Chebyshev type 1 filter
- cheb2mag — response of type 2 Chebyshev filter
- convol — convolution
- 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
- 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
- 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
- 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
- How to design an elliptic filter — How to design an elliptic filter (analog and digital)
- identification
- miscellaneous
- spectral_estimation
- corr — correlation, covariance
- cspect — two sided cross-spectral estimate between 2 discrete time signals using the correlation method
- czt — chirp z-transform algorithm
- intdec — Changes sampling rate of a signal
- mese — maximum entropy spectral estimation
- pspect — two sided cross-spectral estimate between 2 discrete time signals using the Welch's average periodogram method.
- transforms
- cepstrum — cepstrum calculation
- conv — discrete 1-D convolution.
- conv2 — discrete 2-D convolution.
- convol2d — discrete 2-D convolution, using fft.
- detrend — remove constant, linear or piecewise linear trend from a vector
- 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
- frfit — frequency response fit
- hilbert — Discrete-time analytic signal computation of a real signal using Hilbert transform
- ifftshift — inverse of fftshift
- mrfit — frequency response fit
- wfir_gui — Graphical user interface that can be used to interactively design wfir filters
- xcorr — Computes discrete auto or cross correlation
- xcov — Computes discrete auto or cross covariance
- filters
- FFTW
- fftw_flags — set method for fft planner algorithm selection
- fftw_forget_wisdom — Reset fftw wisdom
- get_fftw_wisdom — return fftw wisdom
- set_fftw_wisdom — set fftw wisdom
- Special Functions
- amell — Jacobi's am function
- besselh — Bessel functions of the third kind (aka Hankel functions)
- 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
- 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 — The gamma function.
- gammaln — The logarithm of gamma function.
- legendre — associated Legendre functions
- %k — Jacobi's complete elliptic integral
- %sn — Jacobi's elliptic function
- Randlib
- grand — Random numbers
- ARnoldi PACKage (ARPACK binding)
- dnaupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to a few eigenpairs of a real linear operator This function is obsolete. Please use eigs
- 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 This function is obsolete. Please use eigs
- dsaupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to a few eigenpairs of a real and symmetric linear operator This function is obsolete. Please use eigs
- dseupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to the converged approximations to eigenvalues of A * z = lambda * B * z This function is obsolete. Please use eigs
- eigs — calculates largest eigenvalues and eigenvectors of matrices
- 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. This function is obsolete. Please use eigs
- zneupd — Interface for the Implicitly Restarted Arnoldi Iteration, to compute approximations to the converged approximations to eigenvalues of A * z = lambda * B * z This function is obsolete. Please use eigs
- 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
- Central Tendency
- 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
- 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)
- nanreglin — Linear regression
- nanstdev — standard deviation (ignoring the NANs).
- nansum — Sum of values ignoring NAN's
- thrownan — Eliminates nan values
- Descriptive Statistics
- center — center
- correl — correlation of two variables
- cov — Covariance matrix
- covar — covariance of two variables
- histc — computes an histogram
- median — median (row median, column median,...) of vector/matrix/array entries
- mvvacov (deprecated) — computes variance-covariance matrix This function is obsolete.
- stdev — standard deviation (row orcolumn-wise) of vector/matrix entries
- stdevf — standard deviation
- 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
- wcenter — center and weight
- Hypothesis Testing
- Measures of Dispersion
- Measures of Shape
- Principal Component Analysis
- Sampling
- Summaries
- tabul — frequency of values of a matrix or vector
- reglin — Linear regression
- Cumulated Distribution Functions
- Sparse Matrix
- Sparse Decompositions
- Linear Equations (Iterative Solvers)
- Sparse Matrix Manipulation
- Sparse Matrix Conversion
- adj2sp — converts adjacency form into sparse matrix.
- full — sparse to full matrix conversion
- mtlb_sparse — convert sparse matrix
- sp2adj — converts sparse matrix into adjacency form
- sparse — sparse matrix definition
- spcompack — converts a compressed adjacency representation
- spget — retrieves entries of sparse matrix
- chfact — sparse Cholesky factorization
- chsolve — sparse Cholesky solver
- ordmmd — Compute multiple minimum degree ordering
- 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 — Iterative refinement for a s.p.d. linear system. This function is obsolete.
- 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 — solve a linear sparse (s.p.d.) system given the Cholesky factors
- 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
- Neldermead
- fminsearch — Computes the unconstrained minimimum of given function with the Nelder-Mead algorithm.
- neldermead — Provides direct search optimization algorithms.
- overview — An overview of the Nelder-Mead toolbox.
- nmplot — Provides direct search optimization algorithms.
- 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.
- Nonlinear Least Squares
- Optimization base
- optimbase_cget — Returns the value for the given key.
- optimbase_checkbounds — Checks the bounds.
- optimbase_checkcostfun — Checks the cost function.
- optimbase_checkx0 — Checks initial guess.
- optimbase_configure — Configures the current object.
- optimbase_destroy — Resets the historyfopt and historyxopt fields of an object.
- optimbase_function — Calls cost function.
- optimbase_get — Returns the value for the given key.
- optimbase_hasbounds — Checks if the bounds are specified.
- optimbase_hasconstraints — Checks if the constraints are specified.
- optimbase_hasnlcons — Checks if the non linear constraints are specified.
- optimbase_histget — Returns the history value.
- optimbase_histset — Set the history value at given iteration for the given key.
- optimbase_incriter — Increments the number of iterations.
- optimbase_isfeasible — Checks if the point satisfies constraints.
- optimbase_isinbounds — Checks if the given point satisfies bounds constraints.
- optimbase_isinnonlincons — Checks if the given point satisfies the non-linear constraints.
- optimbase_log — Prints the given message.
- optimbase_new — Creates a new optimization object.
- optimbase_outputcmd — Calls back user's output command.
- optimbase_outstruct — Returns a data structure with type T_OPTDATA.
- overview — An overview of the Optimbase toolbox.
- optimbase_proj2bnds — Returns a projection point.
- optimbase_set — Set the value for the given key.
- optimbase_stoplog — Prints the given stopping message.
- optimbase_terminate — Checks if the algorithm is terminated.
- Optimization simplex
- optimsimplex_center — Computes the center.
- optimsimplex_check — Checks the consistency of internal data
- optimsimplex_compsomefv — Computes the values of the function at vertices points.
- optimsimplex_computefv — Computes the values of the function at vertices points.
- optimsimplex_deltafv — Computes the difference of function values.
- optimsimplex_deltafvmax — Computes the difference of function value between the highest and the lowest vertices.
- optimsimplex_destroy — Destroys the simplex object.
- optimsimplex_dirmat — Computes the directions.
- optimsimplex_fvmean — Computes the mean.
- optimsimplex_fvstdev — Computes the standard deviation.
- optimsimplex_fvvariance — Computes the variance.
- optimsimplex_getall — Returns all the data contained in the simplex object.
- optimsimplex_getallfv — Returns all the function values contained in the simplex object.
- optimsimplex_getallx — Returns all the coordinates.
- optimsimplex_getfv — Returns the function value at given index.
- optimsimplex_getn — Returns the dimension of the space.
- optimsimplex_getnbve — Gets the number of vertices of the simplex.
- optimsimplex_getve — Gets the vertex at the given index.
- optimsimplex_getx — Gets the coordinates of the vertex at given index.
- optimsimplex_gradientfv — Returns the simplex gradient of the function.
- optimsimplex_new — Creates a new simplex object.
- overview — An overview of the Optimsimplex toolbox.
- optimsimplex_reflect — Returns the reflected simplex object.
- optimsimplex_setall — Sets all in the simplex object.
- optimsimplex_setallfv — Sets all the function values.
- optimsimplex_setallx — Sets all the coordinates.
- optimsimplex_setfv — Sets the function value at given index.
- optimsimplex_setn — Sets the dimenson of the space.
- optimsimplex_setnbve — Sets the number of vertices of the simplex.
- optimsimplex_setve — Sets the data at given index in the current simplex.
- optimsimplex_setx — Sets the coordinates at given index into the current simplex.
- optimsimplex_shrink — Shrinks the simplex.
- optimsimplex_size — Computes the size.
- optimsimplex_sort — Sorts the simplex.
- optimsimplex_xbar — Returns the center of n vertices.
- Semidefinite Programming
- aplat — Flattens a list.
- list2vec — Concatenates list entries in a matrix.
- lmisolver — Solve linear matrix inequations.
- lmitool — Graphical tool for solving linear matrix inequations.
- pack — Compress a list of block-diagonal symmetric matrices.
- recons — Inverse function for aplat.
- semidef — Solve semidefinite problems.
- unpack — Uncompress a list of block-diagonal symmetric matrices.
- vec2list — Inverse function of list2vec.
- NDcost — generic external for optim computing gradient using finite differences
- derivative — approximate derivatives of a function. This function is obsolete. Please use the numderivative function instead.
- fsolve — find a zero of a system of n nonlinear functions
- karmarkar — Solves a linear optimization problem.
- numderivative — approximate derivatives of a function (Jacobian or Hessian)
- optim — non-linear optimization routine
- qld — linear quadratic programming solver
- qp_solve — linear quadratic programming solver builtin
- qpsolve — linear quadratic programming solver
- readmps — Reads a Linear Program from a MPS file.
- Neldermead
- Genetic Algorithms
- Algorithms
- 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
- Utilities
- 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
- output_ga_default — A simple output function used for logging purposes
- 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
- Algorithms
- Simulated Annealing
- Algorithms
- optim_sa — A Simulated Annealing optimization method
- Utilities
- 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 neighborhood relationship
- neigh_func_vfsa — The Very Fast Simulated Annealing neighborhood relationship
- 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
- Algorithms
- 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.
- 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.
- 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 Management
- 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
- 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
- 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
- Paths - Filenames
- basename — strip directory and suffix from filenames
- dirname — gets directory 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 — returns path separator for current platform
- splitURL — Split an URL (HTTP, HTTPS, FTP...)
- tempname — creates a file with an unique filename
- copyfile — copies a file
- deletefile — deletes a file
- dispfiles — displays opened files properties
- fileinfo — provides information about a file
- findfiles — finding all files with a given file specification
- fprintfMat — writes a matrix in a file
- fscanfMat — reads a matrix from a text file
- getURL — Download an URL (HTTP, HTTPS, FTP...)
- getmd5 — get md5 checksum
- %io — a variable, which keeps standard input and standard output (file descriptor)
- isfile — checks whether argument is an existing file
- listfiles — list of files
- listvarinfile — list of variables in a saved data file
- maxfiles — sets the limit for the number of files a Scilab is allowed to have open simultaneously
- mclearerr — resets binary file access errors
- mclose — closes an opened file
- mdelete — deletes file(s)
- 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
- msscanf — reads its input from the character string (interface to the C sscanf function)
- mgeti — reads byte or word in a given binary format and returns an int type
- mgetl — reads lines from an text file
- mgetstr — reads a character string from a file
- mopen — opens a file in Scilab
- movefile — moves file or directory
- mput — writes byte or word in a given binary format
- mputl — writes strings in a text file
- mputstr — writes a character string in a file
- mseek — sets current position in a binary file
- mtell — Returns the offset of the current byte relative to the beginning of a file
- newest — returns newest file of a set of files
- 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
- 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
- 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
- contour2dm — compute level curves of a surface defined with a mesh
- 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. This function is obsolete.
- 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
- 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
- paramfplot2d — animated plot of a 2D parametrized curve.
- plot — 2D plot
- plot2d — 2D plot
- plot2d1 — 2D plot (logarithmic axes). This function is obsolete.
- plot2d2 — 2D plot (step function)
- plot2d3 — 2D plot (vertical bars)
- plot2d4 — 2D plot (arrows style)
- 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. This function is obsolete.
- fcontour — level curves on a 3D surface defined by a function. This function is obsolete.
- 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
- 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 entity properties — description of the Label entity properties
- legend — draw graph legend
- Legend entity properties — description of the Legend entity properties.
- legends — draw graph legend
- title — display a title on a graphic window
- zlabel — sets the z-axis label
- 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 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 — Set default axes.
- square — set scales for isometric plot (change the size of the window)
- 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 datatip on a polyline by program
- datatipGetEntities — Get all the entities compatible with datatips in the given axes.
- datatipGetStruct — Retreive the datatips data structure from the polyline entity. This function is obsolete.
- 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.
- datatipSetStruct — Stores the datatips data structure in the polyline entity. Obsolete function.
- datatipSetStyle — Set the datatip style.
- datatipToggle — toggles the data tips mode.
- datatip properties — description of the Datatip entity properties
- 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 or reset a figure or a frame uicontrol.
- 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 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
- handle
- copy — copy a graphics entity.
- delete — delete a graphic entity and its children.
- 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.
- 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
- event handler functions — Prototype of functions which may be used as event handler.
- locate — mouse selection of a set of points
- rubberbox — rubberband box for rectangle selection
- seteventhandler — set an event handler for the current graphic window
- 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
- pie
- pie — draw a pie
- polygon
- property
- 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
- xinfo — Sets the text displayed in the current window status bar.
- 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
- GlobalProperty — to customize 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
- menus — description of the graphic object editor capacities
- pixel_drawing_mode — bitwise pixel rendering functions.
- Segments properties — description of the Segments entity properties
- twinkle — is used to have a graphics entity twinkle
- xchange — transform real to pixel coordinates
- xclear — clears a graphics window. This function is obsolete.
- 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 or 3D 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
- 2d_plot
- Graphics : exporting and printing
- 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
- Borders
- Soft bevel border properties — Description of the soft-bevel and bevel borders properties.
- Compound border properties — Description of the compound borders properties.
- createBorder — Create a border for a frame uicontrol.
- createBorderFont — Create a font for an uicontrol border.
- Empty border properties — Description of the empty borders properties.
- Etched border properties — Description of the etched borders properties.
- Line border properties — Description of the line borders properties.
- Matte border properties — Description of the matte borders properties.
- Titled border properties — Description of the titled borders properties.
- Layouts
- Border Constraints Properties — Description of the border constraints set of properties.
- Border Layout Options Properties — Description of the border layout options set of properties.
- createConstraints — Creates the layout constraints structure for a uicontrol.
- createLayoutOptions — Creates the layout options for a
frame
uicontrol or a figure - Grid Constraints Properties — Description of the grid constraints set of properties.
- Grid Layout Options Properties — Description of the grid layout options set of properties.
- Gridbag Constraints Properties — Description of the gridbag constraints set of properties.
- Gridbag Layout Options Properties — Description of the gridbag layout options set of properties.
- Layout — Description of the different layouts and constraints for uicontrols and figures.
- uitree
- uiConcatTree — Concatenation of trees
- uiCreateNode — Creation of node (for Scilab uitree)
- uiCreateTree — Creation of an uitree
- uiDeleteNode — Deletion in an uitree
- uiDisplayTree — Printing an uitree in GUI mode
- uiDumpTree — Printing an uitree in the console (text mode)
- uiEqualsTree — Comparing two trees
- uiFindNode — Find node in an uitree
- uiGetChildrenNode — Get Children of a node
- uiGetNodePosition — Get the position(s) of a node
- uiGetParentNode — Get Parent of a node
- uiInsertNode — Insertion in a uitree
- 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 or a window
- Console properties — Description of console object properties.
- createWindow — create a window
- 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
- Interactive Editor — Interactive plot editor
- loadGui — Load a graphic user interface from a saved file
- 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.
- saveGui — Save a graphic user interface in a file
- 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.
- tree_show — Display a tree view of a list
- uicontextmenu — Creates a context menu
- uicontrol — create a Graphic User Interface object
- uicontrol properties — Description of the uicontrol properties.
- 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
- uimenu properties — Description of uimenu properties.
- 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.
- Borders
- Data Structures
- boolean — Scilab Objects, boolean variables and operators & | ~
- cell — creates a cell array of empty matrices
- definedfields — returns an index of list's defined fields
- fieldnames — get a tlist, mlist or struct fields names
- getfield — list field extraction
- hypermat — initializes an N dimensional matrix
- hypermatrices — a Scilab object, N dimensional matrix in Scilab
- iscell — checks if a variable is a cell array
- iscellstr — checks if a variable is a cell array of strings
- 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
- lstcat — list concatenation
- makecell — Creates a cell array.
- matrices — Scilab objects, matrices in Scilab
- mlist — Scilab object, matrix oriented typed list definition
- null — delete an element in a list
- rlist — Scilab rational fraction function definition
- setfield — list field insertion
- struct — create a struct
- tlist — Scilab object and typed list definition.
- type — returns the type of a variable
- typename — associates a name to variable type
- typeof — object type
- 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
- bool2s — convert boolean matrix to a zero one matrix.
- Integers
- Strings
- ascii — string ASCII conversions
- asciimat — string matrix ASCII conversions
- blanks — create string of blank characters
- char — converts in a character array
- 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 alphabetic letters
- isnum — tests if a string represents a number
- justify — justify character array
- length — length of object
- part — Extraction of characters from strings
- regexp — find a substring that matches the regular expression string
- sci2exp — converts an expression to a string
- strcat — concatenates 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
- 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 a vector of samples for
t
seconds at frequencyfreq
Hz. - 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 under the form of a Unix hour (timestamp)
- 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
- disp — displays variables
- printf — converts, formats, and writes data to the main scilab window
- sprintf — 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_conversion — mprintf, msprintf, mfprintf conversion specifications
- Xcos
- Batch functions
- lincos — Constructs by linearization a linear state-space model from a general dynamical system described by a Xcos diagram
- 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
- xcosValidateBlockSet — Function to validate Xcos Block interface function.
- xcosValidateCompareBlock — Function to compare two Xcos Blocks.
- xcos_simulate — Function for running xcos simulation in batch mode
- 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
- VirtualCLK0 — Triggered Always Active Blocks
- 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
- SELF_SWITCH — Switch
- SWITCH2_m — Switch2
- SWITCH_f — Switch
- Sinks palette
- Sinks_pal — Sinks palette
- AFFICH_m — Display
- BARXY — y=f(x) animated viewer
- 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 output file. This function is obsolete.
- WRITEAU_f — Write AU sound file
- WRITEC_f — Write to C binary file
- 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)
- PULSE_SC — Pulse Generator
- 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)
- Flowmeter — Thermal-hydraulic Flow sensor
- 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/Xcos 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
- %MODELICA_USER_LIBS — Specify the paths of the directories containing the Modelica class definition files
- block_parameter_error — Displays a parameter input error box for a Xcos block
- buildouttb — Build of the sublist %cpr.state.outtb
- getModelicaPath — Get the Modelica directory path needed by Xcos diagram containing Modelica blocks
- importXcosDiagram — Import a 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
- scicos_getvalue — xwindow dialog for Xcos
- standard_inputs — Get the position of the input ports of a block in Xcos editor.
- standard_origin — Get the position of a block in the Xcos editor.
- standard_outputs — Get the position of the output ports of a block in Xcos editor.
- var2vec — Transform a scilab variable in a vector of double
- vec2var — Transform a vector of double in a scilab variable
- xcosAddToolsMenu — Add a menu item into the Xcos "Tools" menu.
- 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.
- xcosPalDelete — Remove an Xcos palette.
- xcosPalExport — Export a palette instance to a path.
- xcosPalGenerateAllIcons — Update the palette icons (gif files) from a Scilab instance
- xcosPalMove — Move a palette from a category to another one.
- xcosUpdateBlock — Update a block instance
- Solvers
- LSodar — LSodar (short for Livermore Solver for Ordinary Differential equations, with Automatic method switching for stiff and nonstiff problems, and with Root-finding) is a numerical solver providing an efficient and stable method to solve Ordinary Differential Equations (ODEs) Initial Value Problems.
- CVode — CVode (short for C-language Variable-coefficients ODE solver) is a numerical solver providing an efficient and stable method to solve Ordinary Differential Equations (ODEs) Initial Value Problems. It uses either BDF or Adams as implicit integration method, and Newton or Functional iterations.
- Runge-Kutta 4(5) — Runge-Kutta is a numerical solver providing an efficient explicit method to solve Ordinary Differential Equations (ODEs) Initial Value Problems.
- Dormand-Prince 4(5) — Dormand-Prince is a numerical solver providing an efficient explicit method to solve Ordinary Differential Equations (ODEs) Initial Value Problems.
- Implicit Runge-Kutta 4(5) — Implicit Runge-Kutta is a numerical solver providing an efficient and stable implicit method to solve Ordinary Differential Equations (ODEs) Initial Value Problems. Called by xcos.
- IDA — IDA (short for Implicit Differential Algebraic equations system solver) is a numerical solver providing an efficient and stable method to solve Differential Algebraic Equations system (DAEs) Initial Value Problems.
- DDaskr — DDaskr (short for Double-precision Differential Algebraic equations system Solver with Krylov method and Rootfinding) is a numerical solver providing an efficient and stable method to solve Differential Algebraic Equations systems (DAEs) Initial Value Problems.
- Rootfinding — This feature finds roots of continuous functions for Zero-crossing Blocks.
- Comparisons — This page compares solvers to determine which one is best fitted for the studied problem.
- xcos — Block diagram editor and GUI for the hybrid simulator
- xcos_debug_gui — Interactive debugging function to be used in the Debug Xcos block
- Menu_Entries — Xcos editor menu entries
- Batch functions
- Spreadsheet
- csvDefault — Get or set defaults behavior for csv files.
- csvRead — Read comma-separated value file
- csvTextScan — Convert a comma-separated value to a matrix
- csvWrite — Write comma-separated value file
- read_csv — reads comma-separated value file. Outclassed by csvRead
- readxls — reads an Excel file
- write_csv — writes comma-separated value fileOutclassed by csvWrite
- xls_open — opens an Excel file for reading
- xls_read — reads a sheet in an Excel file
- Console
- clc — Clear Command Window
- completion — returns words that start with the text you pass as parameter.
- console cli — Keyboard Shortcuts in NW/NWNI mode
- diary — diary of session
- lines — rows and columns used for display
- prompt — Get/Set current prompt
- tohome — Move the cursor to the upper left corner of the Command Window
- History manager
- addhistory — add lines to current history.
- browsehistory — Open the Scilab history browser
- 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 binary MAT-file.
- matfile_listvar — Lists variables of a Matlab binary MAT-file.
- matfile_open — Opens a Matlab binary MAT-file.
- matfile_varreadnext — Reads next variable in a Matlab binary MAT-file.
- matfile_varwrite — Write a variable in a Matlab binary MAT-file.
- savematfile — write a Matlab MAT-file (binary or ASCII)
- Matlab to Scilab Conversion Tips
- Matlab-Scilab equivalents
- A
- abs (Matlab function) — Absolute value and complex magnitude
- acos (Matlab function) — Inverse cosine
- acosh (Matlab function) — Inverse hyperbolic cosine
- acot (Matlab function) — Inverse cotangent
- acoth (Matlab function) — Inverse hyperbolic cotangent
- acsc (Matlab function) — Inverse cosecant
- acsch (Matlab function) — Inverse hyperbolic cosecant
- all (Matlab function) — Test to determine if all elements are nonzero
- angle (Matlab function) — Phase angle
- any (Matlab function) — Test to determine if any nonzeros elements
- asec (Matlab function) — Inverse secant
- asech (Matlab function) — Inverse hyperbolic secant
- asin (Matlab function) — Inverse sine
- asinh (Matlab function) — Inverse hyperbolic sine
- atan (Matlab function) — Two-quadrant inverse tangent
- atan2 (Matlab function) — Four-quadrant inverse tangent
- atanh (Matlab function) — Inverse hyperbolic tangent
- B
- balance (Matlab function) — Diagonal scaling to improve eigenvalue accuracy
- bar (Matlab function) — Bar histogram
- barh (Matlab function) — Bar histogram horizontal
- beep (Matlab function) — Produce a beep sound
- besseli (Matlab function) — Modified Bessel functions of the first kind
- besselj (Matlab function) — Bessel functions of the first kind
- besselk (Matlab function) — Modified Bessel functions of the second kind
- bessely (Matlab function) — Bessel functions of the second kind
- beta (Matlab function) — Beta function
- bin2dec (Matlab function) — Returns the integer corresponding to a Given binary representation
- bitand (Matlab function) — The AND of two integers
- bitcmp (Matlab function) — The binary complementary of an integer
- bitget (Matlab function) — Gets the bit of an integer whose the positon is given in the input argument
- bitor (Matlab function) — The OR of two integers
- bitxor (Matlab function) — Returns the exclusive OR of two integers
- blanks (Matlab function) — A string of blanks
- blkdiag (Matlab function) — Construct block diagonal matrix from input arguments
- box (Matlab function) — Display axes border
- break (Matlab function) — Terminate execution of a for loop or while loop
- C
- case (Matlab function) — Case switch
- cat (Matlab function) — Arrays concatenation
- cd (Matlab function) — Change/get working directory
- ceil (Matlab function) — Round up
- cell (Matlab function) — Create cell array
- cell2mat (Matlab function) — Convert a cell array into a matrix
- cellstr (Matlab function) — Convert strings vector (or strings matrix) into a cell of strings
- chol (Matlab function) — Cholesky factorization
- cla (Matlab function) — Clear current axes
- clc (Matlab function) — Clear Command Window
- clear (Matlab function) — Remove items from workspace, freeing up system memory
- clf (Matlab function) — Clear current figure window
- clock (Matlab function) — Current time as a date vector
- close (Matlab function) — Delete specified figure
- closereq (Matlab function) — Default figure close request function
- colordef (Matlab function) — Set default property values to display different color schemes
- complex (Matlab function) — Returns the complex form corresponding to the given real part and imaginary part
- conj (Matlab function) — Complex conjugate
- continue (Matlab function) — Keyword to pass control to the next iteration of a loop
- conv (Matlab function) — 1-D Convolution
- conv2 (Matlab function) — 2-D Convolution
- cos (Matlab function) — Cosine
- cosh (Matlab function) — Hyperbolic cosine
- cot (Matlab function) — Cotangent
- coth (Matlab function) — Hyperbolic cotangent
- cputime (Matlab function) — Elapsed CPU time
- csc (Matlab function) — Cosecant
- csch (Matlab function) — Hyperbolic cosecant
- cumprod (Matlab function) — Cumulative product
- cumsum (Matlab function) — Cumulative sum
- D
- date (Matlab function) — Current date string
- dec2bin (Matlab function) — The binary representation of a decimal number
- dec2hex (Matlab function) — Decimal to hexadecimal number conversion
- delete (Matlab function) — Delete files or graphics objects
- det (Matlab function) — Determinant
- diag (Matlab function) — Diagonal including or extracting
- diary (Matlab function) — Save session to a file
- diff (Matlab function) — Differences and approximate derivatives
- dir (Matlab function) — Display directory listing
- disp (Matlab function) — Display text or array
- display (Matlab function) — Overloaded method to display an object
- doc (Matlab function) — Display online documentation
- docopt (Matlab function) — Web browser for UNIX platforms
- dos (Matlab function) — Execute a UNIX command and return result
- double (Matlab function) — Conversion to double precision
- drawnow (Matlab function) — Complete pending drawing events
- E
- echo (Matlab function) — Echo lines during execution
- eig (Matlab function) — Find eigenvalues and eigenvectors
- else (Matlab function) — Conditionally execute statements
- elseif (Matlab function) — Conditionally execute statements
- erf (Matlab function) — Error function
- erfc (Matlab function) — Complementary error function
- erfcx (Matlab function) — Scaled complementary error function
- error (Matlab function) — Display error messages
- etime (Matlab function) — Elapsed time
- eval (Matlab function) — Execute a string containing an instruction/expression
- exist (Matlab function) — Check if a variable or file exists
- exit (Matlab function) — Ends current session
- exp (Matlab function) — Exponential
- expm (Matlab function) — Matrix exponential
- eye (Matlab function) — Identity matrix
- F
- factor (Matlab function) — Prime numbers decomposition
- false (Matlab function) — False array
- fclose (Matlab function) — Close one or more open files
- feof (Matlab function) — Test for end-of-file
- ferror (Matlab function) — Query about errors in file input or output
- feval (Matlab function) — Function evaluation
- fft (Matlab function) — Discrete Fourier transform
- fftshift (Matlab function) — Shift zero-frequency component of discrete Fourier transform to center of spectrum
- fgetl (Matlab function) — Read line(s) from file, discard newline character
- fgets (Matlab function) — Read line from file, keep newline character
- fileparts (Matlab function) — Return filename parts
- filesep (Matlab function) — Return the directory separator for this platform
- find (Matlab function) — Find indices and values of nonzero elements
- findstr (Matlab function) — Find one string within another
- fix (Matlab function) — Round towards zero
- fliplr (Matlab function) — Flip matrix in left/right direction
- flipud (Matlab function) — Flip matrix in up/down direction
- floor (Matlab function) — Round down
- fopen (Matlab function) — Open a file or obtain information about open files
- for (Matlab function) — Repeat statements a specific number of times
- format (Matlab function) — Control display format for output
- fprintf (Matlab function) — Write formatted data to file
- fread (Matlab function) — Read binary data to a file
- frewind (Matlab function) — Move the file position indicator to the beginning of an open file
- fscanf (Matlab function) — Read formatted data to file
- fseek (Matlab function) — Set file position indicator
- ftell (Matlab function) — Get file position indicator
- full (Matlab function) — Convert sparse matrix to full matrix
- fullfile (Matlab function) — Build a full filename from parts
- function (Matlab function) — Function definition
- fwrite (Matlab function) — Write binary data to a file
- G
- gamma (Matlab function) — Gamma function
- gammaln (Matlab function) — Logarithm of gamma function
- getenv (Matlab function) — Get environment variable
- global (Matlab function) — Define a global variable
- graymon (Matlab function) — Set graphics defaults for gray-scale monitors
- grid (Matlab function) — Grid lines for two- and three-dimensional plots
- H
- hankel (Matlab function) — Hankel matrix
- help (Matlab function) — Display help
- helpbrowser (Matlab function) — Display Help browser for access to full online documentation
- helpdesk (Matlab function) — Display Help browser
- helpwin (Matlab function) — Provide access to and display help for all functions
- hess (Matlab function) — Hessenberg form of a matrix
- hold (Matlab function) — Hold current graph
- home (Matlab function) — Move the cursor to the upper left corner of the Command Window
- horzcat (Matlab function) — Horizontal concatenation
- I
- if (Matlab function) — Conditionally execute statements
- ifft (Matlab function) — Inverse discrete Fourier transform
- ifftshift (Matlab function) — Inverse FFT function
- imag (Matlab function) — Complex imaginary part
- input (Matlab function) — Request user input
- int16 (Matlab function) — Convert to 16-bit signed integer
- int32 (Matlab function) — Convert to 32-bit signed integer
- int8 (Matlab function) — Convert to 8-bit signed integer
- interp1 (Matlab function) — One_dimension interpolation function
- inv (Matlab function) — Matrix inverse
- isa (Matlab function) — Detect an object of a given type
- iscell (Matlab function) — Determine if input is a cell array
- ischar (Matlab function) — Determine if item is a character array
- isdir (Matlab function) — Determine if item is a directory
- isempty (Matlab function) — True for empty matrix
- isequal (Matlab function) — Determine if arrays are numerically equal
- isfield (Matlab function) — Determine if input is a structure array field
- isfinite (Matlab function) — True for finite elements
- isglobal (Matlab function) — Determine if item is a global variable
- ishandle (Matlab function) — Determines if values are valid graphics object handles
- ishold (Matlab function) — Return hold state
- isinf (Matlab function) — True for infinite elements
- isinteger (Matlab function) — Detect whether an array has integer data type
- isletter (Matlab function) — True for letters of the alphabet
- islogical (Matlab function) — Determine if item is a logical array
- ismember (Matlab function) — Data sets membership comparison
- isnan (Matlab function) — Detect NaN elements of an array
- isnumeric (Matlab function) — Determine if input is a numeric array
- ispc (Matlab function) — Determine if PC (Windows) version
- isreal (Matlab function) — Determine if all array elements are real numbers
- isscalar (Matlab function) — Determine if input is scalar
- isspace (Matlab function) — Detect elements that are ASCII white spaces
- issparse (Matlab function) — Test if matrix is sparse
- isstr (Matlab function) — Determine if item is a character array
- isstruct (Matlab function) — Determine if input is a structure array
- isunix (Matlab function) — Determine if Unix version
- isvector (Matlab function) — Determine if input is a vector
- K
- keyboard (Matlab function) — Invoke the keyboard in a file
- kron (Matlab function) — Kronecker tensor product
- L
- length (Matlab function) — Length of vector
- linspace (Matlab function) — Linearly spaced vector
- load (Matlab function) — Load workspace variables from disk
- log (Matlab function) — Natural logarithm
- log10 (Matlab function) — Common (base 10) logarithm
- log2 (Matlab function) — Base 2 logarithm and dissect floating point number
- logical (Matlab function) — Convert numeric values to logical
- lookfor (Matlab function) — Search for specified keyword in all help entries
- lower (Matlab function) — Convert string to lower case
- lu (Matlab function) — LU matrix factorization
- M
- max (Matlab function) — Maximum
- min (Matlab function) — Minimum
- mkdir (Matlab function) — Make new folder
- mod (Matlab function) — Modulus after division
- more (Matlab function) — Display Command Window output one screenful at a time
- N
- nargin (Matlab function) — Number of function input arguments
- nargout (Matlab function) — Number of function output arguments
- ndims (Matlab function) — Number of array dimensions
- norm (Matlab function) — Vector and matrix norms
- nthroot (Matlab function) — Real nth root of real numbers
- null (Matlab function) — Null space of a matrix
- num2str (Matlab function) — Number to string conversion
- O
- ones (Matlab function) — Create an array of all ones
- otherwise (Matlab function) — Default part of switch/select statement
- pause (Matlab function) — Halt execution temporarily
- Operators
- + (Matlab operator) — Plus
- & (Matlab operator) — Logical AND
- : (Matlab operator) — Colon
- .\ (Matlab operator) — Elementwise left division
- .* (Matlab operator) — Elementwise multiplication
- .^ (Matlab operator) — Elementwise exponent
- ./ (Matlab operator) — Elementwise right division
- .' (Matlab operator) — Elementwise transpose
- == (Matlab operator) — Equal to
- > (Matlab operator) — Greater than
- >= (Matlab operator) — Greater or equal to
- \ (Matlab operator) — Left division
- < (Matlab operator) — Smaller than
- <= (Matlab operator) — Smaller or equal to
- * (Matlab operator) — Multiplication
- ~ (Matlab operator) — Negation
- ~= (Matlab operator) — Not equal to
- | (Matlab operator) — Logical OR
- ^ (Matlab operator) — Exponent
- / (Matlab operator) — Right division
- - (Matlab operator) — Minus
- ' (Matlab operator) — Transpose
- P
- perms (Matlab function) — Array of all permutations of vector components
- permute (Matlab function) — Permute the dimensions of an array
- pie (Matlab function) — circular graphic
- plot (Matlab function) — Linear 2-D plot
- pow2 (Matlab function) — Base 2 power and scale floating-point numbers
- primes (Matlab function) — Returns the primes numbers included between 1 and given number
- prod (Matlab function) — Product of array elements
- Q
- qr (Matlab function) — Orthogonal-triangular decomposition
- quit (Matlab function) — Terminate session
- R
- rand (Matlab function) — Uniformly distributed random numbers and arrays
- randn (Matlab function) — Normally distributed random numbers and arrays
- randperm (Matlab function) — Uniformly distributed random numbers and arrays
- rcond (Matlab function) — Matrix reciprocal condition number estimate
- real (Matlab function) — Real part of a complex number
- realmax (Matlab function) — Largest positive floating-point number
- realmin (Matlab function) — Smallest positive floating-point number
- rem (Matlab function) — Remainder after division
- repmat (Matlab function) — Replicate and tile an array
- reshape (Matlab function) — Reshape array
- return (Matlab function) — Return to the invoking function
- round (Matlab function) — Round to nearest integer
- S
- save (Matlab function) — Save workspace variables from disk
- schur (Matlab function) — Schur decomposition
- setstr (Matlab function) — Set string flag
- sign (Matlab function) — Signum function
- sin (Matlab function) — Sine
- sinh (Matlab function) — Hyperbolic sine
- size (Matlab function) — Array dimension
- sort (Matlab function) — Sort elements in ascending order
- sparse (Matlab function) — Create sparse matrix
- sqrt (Matlab function) — Square root
- strcmp (Matlab function) — Compare strings
- strcmpi (Matlab function) — Compare strings ignoring case
- strfind (Matlab function) — Find one string within another
- strrep (Matlab function) — String search and replace
- struct (Matlab function) — Create struct array
- sum (Matlab function) — Sum of array elements
- surf (Matlab function) — 3-D surface plot
- svd (Matlab function) — Singular value decomposition
- switch (Matlab function) — Switch among several cases based on expression
- T
- tan (Matlab function) — Tangent
- tanh (Matlab function) — Hyperbolic tangent
- tic (Matlab function) — Starts a stopwatch timer
- title (Matlab function) — Display a title on a graphic window
- toc (Matlab function) — Read the stopwatch timer
- toeplitz (Matlab function) — Toeplitz matrix
- tril (Matlab function) — Lower triangular part of a matrix
- triu (Matlab function) — Upper triangular part of a matrix
- true (Matlab function) — True array
- type (Matlab function) — List file
- U
- uigetdir (Matlab function) — Standard dialog box for selecting a directory
- uint16 (Matlab function) — Convert to 16-bit unsigned integer
- uint32 (Matlab function) — Convert to 32-bit unsigned integer
- uint8 (Matlab function) — Convert to 8-bit unsigned integer
- unix (Matlab function) — Execute a UNIX command and return result
- upper (Matlab function) — Convert string to upper case
- V
- varargin (Matlab function) — Pass variable numbers of arguments
- varargout (Matlab function) — Return variable numbers of arguments
- vertcat (Matlab function) — Vertical concatenation
- Variables
- ans (Matlab variable) — The most recent answer
- end (Matlab variable) — Last index
- eps (Matlab variable) — Floating-point relative accuracy
- i (Matlab variable) — Imaginary unit
- j (Matlab variable) — Imaginary unit
- pi (Matlab variable) — Ratio of a circle's circumference to its diameter
- W
- waitforbuttonpress (Matlab function) — Wait for key or mouse button press
- warning (Matlab function) — Display warning messages
- while (Matlab function) — Repeat statements an indefinite number of times
- who (Matlab function) — List variables in the workspace
- whos (Matlab function) — List variables in the workspace
- winqueryreg (Matlab function) — Get item from Microsoft Windows registry
- X
- xlabel (Matlab function) — Display a string along the x axis
- Y
- ylabel (Matlab function) — Display a string along the y axis
- Z
- zeros (Matlab function) — Create an array of all zeros
- zlabel (Matlab function) — Display a string along the z axis
- 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
- Matlab-Scilab_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
- firstnonsingleton — Finds first dimension which is not 1
- 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_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_mode — switch Matlab like operations
- 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_s — Matlab subtraction 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
- 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
- readgateway — get primitives list of a module
- what — list the Scilab primitives
- Libraries
- genlib — build library from functions in given directory
- get_function_path — get source file path of a library function
- lib — library definition
- librarieslist — get scilab libraries
- library — library datatype description
- libraryinfo — get macros and path of a scilab library
- whereis — name of library containing a function
- profiling
- add_profiling — Enables the profiling of a function
- plotprofile — Displays the profiling charts of a function
- profile — Returns the profiling results of a function
- remove_profiling — Disables the profiling of a function
- reset_profiling — Resets profiling counters of a function.
- showprofile — Outputs the function profiling results to the console
- argn — Returns the number of input/output arguments in a function call
- bytecode — given a function returns the "bytecode" of a function in a Scilab array and conversely.
- bytecodewalk — walk in function bytecode applying transformation.
- code2str — returns character string associated with Scilab integer codes. This function is obsolete.
- comp — scilab function compilation
- deff — on-line definition of function
- edit — function editing
- exec — script file execution
- execstr — execute Scilab code in strings
- fun2string — generates ASCII definition of a Scilab function
- funcprot — switch scilab functions protection mode
- endfunction — closes a function definition
- functions — Scilab procedures and Scilab objects
- getd — Load all functions defined in a directory
- head_comments — display Scilab function header comments
- listfunctions — properties of all functions in the workspace
- macr2lst — function to list conversion
- macr2tree — function to tree conversion
- macro — Scilab procedure and Scilab object
- macrovar — variables of function
- mode — select a mode in an exec-file
- overloading — display, functions and operators overloading capabilities
- recompilefunction — recompiles a scilab function, changing its type
- sciargs — scilab command line arguments
- str2code — returns Scilab integer codes associated with a character string. This function is obsolete.
- tree2code — generates ASCII definition of a Scilab function
- varargin — variable number of arguments in an input argument list
- varargout — variable numbers of arguments in an output argument list
- Built-in & external
- Development tools
- Assert
- Assert Overview — An overview of the Assert module.
- assert_checkalmostequal — Check that computed and expected are numerically close.
- assert_checkequal — Check that computed and expected are equal.
- assert_checkerror — Check that an instruction produces the expected error.
- assert_checkfalse — Check that condition is false.
- assert_checkfilesequal — Check that two files are equal.
- assert_checktrue — Check that condition is true.
- assert_comparecomplex — Compare complex numbers with a tolerance.
- assert_computedigits — Returns the number of significant digits in computed result.
- assert_cond2reltol — Suggests a relative error, computed from the condition number.
- assert_cond2reqdigits — Suggests the number of required digits, given the condition number.
- assert_generror — Generates an error.
- bench_run — Launch benchmark tests
- example_run — Launch the examples found in help pages.
- test_run — Launch tests
- user — interfacing a Fortran or C routine
- Assert
- Demo Tools
- add_demo — Add an entry in the demos list
- 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_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 if symbol loaded with dynamic link
- call — Fortran or C user routines call
- chooselcccompiler — moved as toolbox in ATOMS
- configure_ifort — 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_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 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 and compatible compilers — supported and compatible compilers by Scilab
- ulink — unlink/unload a dynamically linked shared object
- ATOMS
- Getting started —
- Functions Summary —
- atomsAutoload — Load the modules marked as "autoload"
- 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
- atomsCheckModule — Check the given list of ATOMS modules
- atomsDepTreeShow — Show the dependency tree of a module
- atomsGetConfig — Get ATOMS system parameters
- atomsGetInstalled — Get the list of installed external modules
- atomsGetInstalledPath — Get the install path of installed external modules
- atomsGetLoaded — Get the list of loaded external modules
- atomsGetLoadedPath — Returns the path of the installation directory 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 — Load one or several external modules
- atomsQuit — Unload (call .quit file of) external modules previously loaded by ATOMS
- 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
- atomsRestoreConfig — Restore the configuration from the backup file
- atomsSaveConfig — Make a backup of the configuration file
- atomsSearch — Searches for external modules.
- atomsSetConfig — Manage ATOMS system parameters
- atomsShow — Show the characteristics of a module
- atomsSystemInit — Sets the rightful write access for the ATOMS system
- atomsSystemUpdate — Update the list of available modules
- atomsTest — Execute tests of given module installed
- atomsUpdate — Update one or several external modules
- atomsVersion — Show the ATOMS's version of Scilab
- 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
- 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 — Call the text editor as defined in the preferences
- scinotes — Scinotes: Embedded Scilab text editor
- UI Data
- browsevar — Scilab variable browser
- closeEditvar — Close the variable editor
- editvar — Scilab variable editor
- filebrowser — Open the Scilab file browser
- 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
- 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 — Variable defining the path of help directories
- 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
- 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 an addchapter.sce script (toolbox compilation process)
- tbx_build_loader — Generate loader.sce and unloader scripts (toolbox compilation process)
- tbx_build_localization — Build localization "mo" file from "po" files (toolbox compilation process)
- tbx_build_macros — Compile macros (toolbox compilation process)
- tbx_build_pal_loader — Generate a loader_pal.sce script for loading Xcos palette module(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)
- tbx_generate_pofile — Extract localized strings from toolbox sources (toolbox compilation process)
- Scilab MPI
- MPI_Bcast — Broadcasts a message from the process with rank root to all other processes of the group.
- MPI_Init — Initialize the MPI environnement
- MPI_Irecv — Nonblocking receive of data from a node
- MPI_Isend — Nonblocking send data from a node to an other
- MPI_Recv — Recv data from a node
- MPI_Send — Send data from a node to an other
- MPI_Wait — Waits for an MPI request to complete
- MPI — Access to MPI features from Scilab
- MPI implementation — Technical details about the implementation
- Localization
- addlocalizationdomain — add a new domain in localization mechanism.
- dgettext — get text translated into the current locale and a specific domain
- getdefaultlanguage — returns the default language used by Scilab
- getlanguage — returns current language used by Scilab.
- _ — Similar to gettext
- setdefaultlanguage — sets and saves the internal LANGUAGE value.
- setlanguage — sets the internal LANGUAGE value (for Windows only)
- 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.
- boolean example — 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.
- boolean sparse example — Boolean sparse use case.
- Scilab Gateway API
- How to
- Calling a scilab function (macros) from a C gateway — Calling a scilab function (macros) from a C interface
- CheckLhs (deprecated) — C macro which checks the number of output arguments present in the calling Scilab function. This function is obsolete.
- CheckRhs (deprecated) — C macro which checks the number of input arguments present in the calling Scilab function. This function is obsolete.
- Lhs (deprecated) — A C gateway function which provides the number of output arguments present in the calling Scilab function This function is obsolete.
- LhsVar (deprecated) — a C gateway function which specifies which parameters created inside the C gateway will be returned as an output argument into Scilab. This function is obsolete.
- Rhs (deprecated) — A C gateway function which provides the number of input arguments present in the calling Scilab function This function is obsolete.
- 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.
- double example — Double use case.
- handle
- isHandleType — Check if it is a handle variable.
- getScalarHandle — Read scalar handle data from a gateway argument.
- createScalarHandle — Create scalar handle variable in Scilab memory.
- handle example — Handle use case.
- hypermat
- isHypermatType — Check if it is a hypermatrix variable.
- getHypermatOfDouble — Get a hypermatrix of double variable.
- getHypermatOfInt — Get a hypermatrix of integer variable.
- integer
- isIntegerType — Check if it is a double variable.
- getScalarInteger8 — Get scalar integer variable.
- createScalarInteger8 — Create scalar integer variable.
- integer example — Integer use case.
- List manipulation
- isListType, isTListType, isMListType — Check if it is a list, mlist, tlist variable.
- Boolean reading (Scilab gateway) — How to read matrix of boolean in a list.
- Boolean writing (Scilab gateway) — How to add matrix of boolean in a list.
- Boolean sparse reading (Scilab gateway) — How to read boolean sparse in a list.
- Boolean sparse writing (Scilab gateway) — How to add boolean sparse matrix in a list.
- Create List (Scilab gateway) — How to get create a list in Scilab memory.
- Double reading (Scilab gateway) — How to read matrix of double in a list.
- Double writing (Scilab gateway) — How to add matrix of double in a list.
- Get child item (Scilab gateway) — How to get the address of a list child.
- Item Number (Scilab gateway) — How to get the number of items in a list (list, mlist, tlist).
- Integer reading (Scilab gateway) — How to read matrix of integer in a list.
- Integer writing (Scilab gateway) — How to add matrix of integer in a list.
- Pointer reading (Scilab gateway) — How to read pointer in a list.
- Pointer writing (Scilab gateway) — How to add pointer in a list.
- Polynomial reading (Scilab gateway) — How to read matrix of polynomial in a list.
- Polynomial writing (Scilab gateway) — How to add matrix of polynomial in a list.
- Sparse reading (Scilab gateway) — How to read sparse in a list.
- Sparse writing (Scilab gateway) — How to add sparse matrix in a list.
- String reading (Scilab gateway) — How to read matrix of string in a list.
- String writing (Scilab gateway) — How to add matrix of string in a list.
- Low level functions
- AssignOutputVariable — a C gateway function which specifies which parameters created inside the C gateway will be returned as an output argument into Scilab.
- CallOverloadFunction — a C gateway function uses to call overload function or macro
- CheckInputArgument — C function which checks the number of input arguments present in the calling Scilab function.
- CheckOutputArgument — C function which checks the number of output arguments present in the calling Scilab function.
- ReturnArguments — A C gateway function which returns the various variables.
- Boolean reading (Scilab gateway) — How to read matrix of boolean.
- Boolean writing (Scilab gateway) — How to write matrices of boolean.
- Boolean sparse reading (Scilab gateway) — How to read boolean sparse in a gateway.
- Boolean sparse writing (Scilab gateway) — How to add boolean sparse matrix in a gateway.
- Check variable dimensions (Scilab gateway) — A C gateway functions which check dimensions of a variable.
- Variable Reference (Scilab gateway) — How to get the address of an argument or a variable in a gateway.
- Variable dimension (Scilab gateway) — How to get the dimensions of an argument or a variable stored as matrix.
- Variable Type (Scilab gateway) — How to get the type of an argument or a variable within a gateway.
- Variable Complexity (Scilab gateway) — How to get the argument or variable complexity.
- Matrix Type (Scilab gateway) — How to know if an argument or a variable is stored as a matrix.
- deleteNamedVariable — a C gateway function uses to delete a variable from name
- Double reading (Scilab gateway) — How to read matrices of double in a gateway.
- Double writing (Scilab gateway) — How to write matrices of doubles in a gateway.
- getNbInputArgument (Scilab gateway) — A C gateway function which provides the number of input arguments present in the calling Scilab function
- getNbOutputArgument (Scilab gateway) — A C gateway function which provides the number of output arguments present in the calling Scilab function
- Handle reading (Scilab gateway) — How to read matrix of handle.
- Handle writing (Scilab gateway) — How to write matrices of handle.
- Integer Precision (Scilab gateway) — How to get precision of an integer matrix.
- Integer reading (Scilab gateway) — How to read matrices of integer in a gateway.
- Integer writing (Scilab gateway) — How to write matrices of integers in a gateway.
- nbInputArgument (Scilab gateway) — A C gateway function which provides the number of input arguments present in the calling Scilab function
- Pointer reading (Scilab gateway) — How to read pointer in a gateway.
- Pointer writing (Scilab gateway) — How to write pointer in a gateway.
- Polynomial Symbolic Variable (Scilab gateway) — How to get the symbolic variable name.
- Polynomial reading (Scilab gateway) — How to read matrices of polynomials in a gateway.
- Polynomial writing (Scilab gateway) — How to write matrices of polynomials in a gateway.
- Sparse matrix reading (Scilab gateway) — How to read sparse matrices in a gateway.
- Sparse writing (Scilab gateway) — How to write sparse matrix in a gateway.
- String reading (Scilab gateway) — How to read matrices of strings in a gateway.
- String writing (Scilab gateway) — How to write matrices of string in a gateway.
- optionals
- polynomial
- isPolyType — Check if it is a polynomial variable.
- getAllocatedSinglePoly — Get single polynomial variable.
- getAllocatedSinglePoly — Get single complex polynomial variable.
- getAllocatedMatrixOfPoly — Get matrix of polynomial variable.
- getAllocatedMatrixOfComplexPoly — Get matrix of complex polynomial variable.
- freeAllocatedSinglePoly — Free memory allocated by getAllocatedSinglePoly function.
- freeAllocatedSingleComplexPoly — Free memory allocated by getAllocatedSingleComplexPoly function.
- freeAllocatedSinglePoly — Free memory allocated by getAllocatedSinglePoly function.
- freeAllocatedSinglePoly — Free memory allocated by getAllocatedSinglePoly function.
- polynomial example — 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.
- sparse example — Sparse use case.
- string
- isStringType — Check if it is a string variable.
- getAllocatedSingleString — Get single string variable.
- getAllocatedMatrixOfString — Get matrix of string variable.
- createSingleString — create a single string variable.
- freeAllocatedSingleString — Free memory allocated by getAllocatedSinglePoly function.
- freeAllocatedMatrixOfString — Free memory allocated by getAllocatedMatrixOfString function.
- string example — String use case.
- api_scilab — api_scilab is the Scilab interface to read/write data from/to Scilab memory
- Getting started with API_Scilab — How to load a C, C++ or fortran code in the Scilab engine as a new function
- boolean
- call_scilab API (Scilab engine)
- Boolean management — How to manage Scilab's boolean read and write process using call_scilab and api_scilab
- Complex management — 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
- Double management — 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
- String management — 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 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)
- 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.
- 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
- jconvMatrixMethod — Set the way to convert matrices This function is obsolete.
- 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 functionnement 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
- Compile and run with javasci v2 — How to compile a Java application using Javasci v2
- javasci — Call Scilab engine from a Java application
- javasci FAQ — 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
- Intersci
- intersci — Scilab tool to interface C or Fortran functions with scilab. Deprecated: Please use SWIG
- Preferences
- getPreferencesValue — Get preferences value
- preferences — Open the Scilab Preferences window
- SciNotes preferences — SciNotes general preferences
- setPreferencesValue — Set preferences value
- Windows tools
- consolebox — show or hide console box (Windows)
- createGUID — Creates a GUID (Windows only)
- dos — shell (cmd) command execution (Windows only)
- 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 — shell (powershell) command execution (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)
Report an issue | ||