scilab-2024.1.0
Ajuda do Scilab
Scilab
Scilab palavra-chave
percent — caractere especial (%)
backslash — (\) divisão matricial direita-esquerda: exact or least square solution
brackets [,;] — Concatenation. Recipients of an assignment. Results of a function
colon (:) — operador dois pontos
comma — (,) separador de colunas, instruções e argumentos
comments — (// or /*...*/) comments
comparison — comparação, operadores relacionais
dollar — ($) last index
dot — (.) símbolo de ponto
equal — (=) atribuição ou comparação, sinal de igualdade
getscilabkeywords — retorna uma lista com todas as palavras-chave do
Scilab
hat — (^) exponentiation
less — (<) comparação "menor do que"
minus — (-) operador de subtração, mudança de sinal
not — (~) não lógico
parentheses — ( ) parênteses esquerdo e direito
plus (+) — Adição numérica. Concatenação de texto (colagem)
quote — (') transpose operator, string delimiter
semicolon (;) — (;) fim de expressão e separador de linhas
slash — (/) divisão esquerda-direita e feedback
("resposta")
star — (*) operador de multiplicação
symbols — nomes dos operadores Scilab
tilde — (~) não lógico
underscore _ — ignored output argument. gettext()
alias
Control flow
abort — Interrupção de avaliação
arguments — keyword to check function arguments
Arguments Validators — List of predefined validators that can be used in arguments block.
break — palavra-chave para interromper um laço ("loop") (significa
"interromper (neste ponto)")
case — palavra-chave usada na estrutura select (significa
"caso...")
continue — Palavra-chave para passar o controle para a próxima iteração
de um laço ("loop") (significa "continuar")
do — palavra-chave de linguagem para laços ("loops") (significa
"faça...")
else — palavra-chave usada na estrutura "if-then-else" (significa
"senão...")
elseif — palavra-chave usada na estrutura "if-then-else" (significa
"senão, se...")
end — Palavra-chave end (significa "fim")
for — palavra-chave de linguagem para laços ("loops") (significa "para...")
halt — para execução
if then else — Execução condicional (significa "se então senão")
pause — pausa temporariamente a execução atual e permite instruções no console.
resume — retorna ou pára a execução de uma função e copia algumas de
suas variáveis locais
return — retorna ou pára a execução de uma função e copia algumas de
suas variáveis locais
select — select keyword
then — Palavra-chave usada na estrutura "if-then-else" (significa
"então...")
try — início de um bloco try numa instrução de controle try-catch
(significa "tentar...")
while — palavra-chave da estrutura while (significa
"enquanto...")
Configuration
banner — exibe banner do Scilab
getdebuginfo — retorna informações sobre o Scilab para o debug
getmemory — retorna as memórias livre e total do sistema
getmodules — retorna a lista de módulos instalados no Scilab
getos — retorna o nome e a versão do Sistema Operacional
getscilabmode — retorna o modo do Scilab
getshell — retorna o interpretador de comando corrente
getversion — retorna o nome da versão do Scilab
oldEmptyBehaviour — Controls the operation+ and operation- behaviour for Scilab
recursionlimit — get or set the current or maximal allowed depth of nested calls
sciargs — scilab command line arguments
ver — informação de versão sobre Scilab
with_javasci — Checa se o Scilab foi construído com a interface
Java
with_macros_source — Verifica se a fonte de macros está instalada
with_module — checa se um módulo Scilab foi instalado
Debugging
debug — enters the Scilab debugger mode
where — retorna a árvore de chamamento de instruções
corrente
whereami — exibe a árvore de chamamento de instruções corrente
Error handling
errclear — limpeza de erros
error — relata um erro de tempo de execução
error_table — list of main standard errors messages
lasterror — retorna a última mensagem de erro registrada
warning — mensagens de aviso
types
boolean — objetos Scilab: variáveis booleanas e operadores '&', '|'
e '~'
functions — procedimentos Scilab e objetos Scilab
hypermatrices — objeto do Scilab: matrizes n-dimensionais
library — library datatype
matrices — objeto do Scilab: matrizes
rational — razão de polinômios
strings — objeto Scilab, strings (cadeias de caracteres)
type — tipo de variável
typename — associa um nome ao tipo de variável
typeof — tipo do objeto
Variables
Constants
SCI, WSCI — variable containing the value of the root path of Scilab.
SCIHOME — contains the path to preferences, history files of your Scilab
session.
TMPDIR — temporary directory path
home — Gives the user directory.
%chars — Selected sets of Unicode characters
%e — Euler number.
%eps — epsilon (floating-point relative accuracy)
%f or %F — Boolean variable for false.
%i — imaginary unit
%inf — infinity
%nan — not-a-number
%pi — ratio of circle's circumference to its diameter
%s — A variable used to define polynomials.
%t or %T — Boolean variable for true.
%z — A variable used to define polynomials.
checkNamedArguments — Return list of unexpected named arguments
clear — cancela variáveis
clearglobal — cancela variáveis globais
exists — verifica existência de variáveis
global — define variável global
isdef — verifica existência de variáveis
isglobal — checks if a local variable has a global counterpart
names — scilab names syntax
predef — proteção de variáveis
who — listagem de variáveis
who_user — listagem das variáveis do usuário
whos — listing of variables in long form
exit — Ends the current Scilab session
quit — Decresce o nível de pausa ou termina o Scilab
startup — arquivo de inicialização
scilab — runs Scilab in interactive or batch mode with command line options
Equações Diferenciais
Funções Elementares
Bitwise operations
bitand — bitwise logical AND between element-wise integers of 2 arrays
bitcmp — bitwise complement of integers
bitget — Extracts from integers bits of given indices
bitor — bitwise logical OR between element-wise integers of 2 arrays
bitset — Sets bits of given indices in some integers
bitstring — A string giving the literal bit representation of a number
bitxor — bitwise logical XOR between element-wise integers of 2 arrays
Complex
angle — argument of complex numbers, in radians
complex — Build an array of complex numbers from their parts
conj — matriz complexa conjugada
csgn — returns the sign of a vector of real of complex values
imag — parte imaginária dos números complexos
imult — multiplicação pela parte imaginária i
isreal — verifica se uma variável é armazenada como real ou complexa.
real — parte real dos números complexos
Matemática discreta
factor — fatoração
factorial — factorial function : product of the n first positive integers
gcd — Greatest (positive) Common Divisor
lcm — mínimo múltiplo comum (positivo) de inteiros ou de polinômios
nchoosek — Computes binomial numbers (n,k) = numbers of combinations
primes — função dos primos
rat — aproximação racional de ponto-flutuante
Elementary matrices
random
grand — Generate random numbers
prbs_a — Generates a pseudo random binary sequence
rand — gerador de números randômico
sample — Sampling: random draw with replacement
samplef — sample values with replacement from a population
with given frequencies.
samwr — Sampling without replacement
blockdiag — Creates a block diagonal matrix from provided arrays. Block diagonal system connection.
diag — inclusão ou extração diagonal
empty [] — empty matrix. Array ranges destructor.
eye — matriz identidade
linspace — generates linearly spaced numbers between 2 reached bounds
logspace — vetor espaçado logaritmicamente
meshgrid — Cria matrizes ou arrays 3-D a partir de vetores replicados em 2 ou 3 dimensões
ndgrid — constrói matrizes ou matrizes N-D, replicando alguns vetores dadas
ones — matriz de entradas todas iguais a 1
perms — Generate the table of permutations of given elements
repmat — Replicate and tile an array
squarewave — gera uma onda quadrada de período 2*%pi
testmatrix — gera algumas matrizes particulares
toeplitz — Toeplitz matrix (chosen constant diagonal bands)
zeros — matriz feita de zeros
Exponential
exp — exponencial em relação aos elementos
expm — exponencial de matriz quadrada (matriz
exponencial)
log — logaritmo natural
log10 — logaritmo na base 10
log1p — computa, com precisão, o logaritmo natural de seu argumento
acrescido de uma unidade
log2 — Base-2 logarithm. Base-2 exponent and mantissa of some real numbers
logm — logaritmo de matriz quadrada (matriz logaritmo)
nthroot — Real nth root of real numbers
power — (^,.^) power operation
sqrt — raiz quadrada
sqrtm — raiz quadrada da matriz (matriz raiz quadrada)
Ponto flutuante
ceil — arredonda o número para o inteiro maior ou igual ao
número
clean — limpa matrizes (arredonda para zero entradas pequenas)
double — converts inttype integers or booleans into decimal encoding
fix — arredonda em direção a zero
floor — arredondamento para o inteiro menor ou igual ao
número
format — set the default output format of decimal numbers
ieee — ajusta o modo de exceção de ponto flutuante
int — parte inteira
isinf — tests for infinite elements
isnan — verifica entradas NaN ("não é um número")
nearfloat — get previous or next floating-point number
nextpow2 — próxima potência de 2 mais alta
number_properties — determina parâmetros de ponto flutuante
round — arredondamento para inteiro mais próximo
signed zero -0 — Processing of -0 versus 0
Integer representation
base2dec — conversão da base b para inteiros
bin2dec — conversão de representação binária para inteira
dec2base — Convert decimal to base N number in string
dec2bin — representação binária
dec2hex — representação hexadecimal de inteiros
dec2oct — representação octal de inteiros
hex2dec — conversão de representação hexadecimal para
inteiros
oct2dec — conversão de octais para inteiros
Inteiros
iconvert — conversão para representação inteira de 1 a 8 bytes
int8 — conversão para representação de inteiro de 1 byte
inttype — tipos de dados inteiros
Matrix manipulation
Shape tests
iscolumn — check if a variable is a column
ismatrix — checks if an object is a non-empty 1D or 2D matrix or array
isrow — check if a variable is a row
isscalar — check if a variable is a scalar.
issquare — check if a variable is a square matrix
isvector — check if a variable is a vector
cat — empilha matrizes ou arrays vectoriais numa hipermatriz ou hiperarray
circshift — circularly shifts elements or subarrays of an array (regular, of structures, cells, custom)
flipdim — reverses the order of (blocks of) rows, columns, pages.. of an array
matrix — Muda a forma de vetores ou matrizes
permute — permutes the dimensions of an array
pertrans — matriz pertransposta
resize_matrix — trim or/and extend (and cast) a matrix or hypermatrix
squeeze — removes singleton dimensions of a ND-array
tril — parte triangular inferior de uma matriz
triu — triângulo superior da matriz
Matrix operations
abs — valor absoluto, magnitude
and — logical AND between the elements of a boolean or numerical array
cross — vector cross product
cumprod — produto cumulativo
cumsum — somas cumulativas parciais dos elementos de uma matriz
kron .*. — Produto de Kronecker. Weighted array replication
kron .\. ./. — Kronecker left and right divisions
max — maximum
min — minimum
norm — normas de um vetor ou uma matriz
or — logical OR over the elements of a boolean or numerical array
prod — produto
sign — signum function
sum — soma (soma linha, soma coluna) de entradas de um vetor ou
matriz
Search and sort
dsearch — Busca binária (também conhecida como busca dicótoma em
francês)
find — fornece os índices de elementos %T ou diferentes de zero
gsort — sorts boolean, numerical and string arrays
members — count (and locate) in an array each element or row or column of another array
vectorfind — locates occurences of a (wildcarded) vector in a matrix or hypermatrix
Set operations
intersect — elements or rows or columns met in both input arrays, without duplicates
setdiff — returns elements that are in a set but not in another one.
union — extrai componentes da união de um vetor
unique — remover todos os componentes duplicados de um vetor ou uma matriz
Trigonometria
Matrix-wise processing
acoshm — arco-cosseno hiperbólico da matriz (matriz arco-cosseno
hiperbólico)
acosm — arco-coseno da matriz (matriz arco-cosseno)
asinhm — arco-seno hiperbólico da matriz (matriz arco-seno
hiperbólico)
asinm — arco-seno da matriz (matriz arco-seno)
atanhm — Arco-tangente hiperbólico da matriz (matriz arco-tangente
hiperbólico)
atanm — arco-tangente da matriz quadrada (matriz
arco-tangente)
coshm — co-seno hiperbólico da matriz (matriz co-seno
hiperbólico)
cosm — co-seno da matriz (matriz co-seno)
cothm — cotangente hiperbólica da matriz (matriz cotangente
hiperbólica)
sinhm — seno hiperbólico da matriz (matriz seno
hiperbólico)
sinm — matriz seno
tanhm — tangente hiperbólica da matriz (matriz tangente
hiperbólica)
tanm — tangente da matriz (matriz tangente)
acos — arco-cosseno em relação aos elementos
acosd — arco-cosseno elemento a elemento com resultado em
graus
acosh — hyperbolic cosine inverse
acot — computa o arco-cotangente elemento a elemento do
argumento
acotd — computa o arco-cotangente elemento a elemento do argumento com,
resultado em graus
acoth — arco-cotangente hiperbólico elemento a elemento
acsc — computa o arco-cossecante elemento a elemento do
argumento
acscd — computa o arco-cossecante elemento a elemento do argumento com
resutado em graus
acsch — computa o arco-cossecante hiperbólico elemento a elemento do
argumento
asec — computa o arco-secante elemento a elemento do
argumento
asecd — computa o arco-secante elemento a elemento do argumento com
resultados em graus
asech — computa o arco-secante hiperbólico elemento a elemento do
argumento
asin — arco-seno
asind — arco-seno, resultado em graus
asinh — arco-seno hiperbólico
atan — arco-tangente 2-quadrantes e 4-quadrantes
atand — arcos-tangentes 2-quadrantes e 4-quadrantes elemento a
elemento do argumento com resultados em graus
atanh — arco-tangente hiperbólico
cos — função seno
cosd — função co-seno elemento a elemento, argumento dado em
graus
cosh — co-seno hiperbólico
cotd — cotangent elemento a elemento do argumento dado em
graus
cotg — cotangente
coth — cotangente hiperbólica
csc — computa a cossecante do argumento elemento a
elemento
cscd — computa a cossecante elemento a elemento do argumento em
graus
csch — computa a cossecante hipertbólica do argumento elemento a
elemento
sec — computa a secante elemento a elemento do
argumento.
secd — computa a secante elemento a elemento do argumento em
graus
sech — computa a secante hipertbólica do argumento elemento a
elemento
sin — função seno
sind — função seno, argumento em graus
sinh — seno hiperbólico
tan — tangente
tand — tangente com o argumento em graus
tanh — tangente hiperbólica
&, && — Binary AND between integers. Logical AND over/between booleans and numbers
bernstein — compute the n-order Bernstein matrix
extraction — extração de entradas de matrizes e listas
ind2sub — conversão de índice linear para matriz de valores
subescritos
insertion — atribuição ou modificação parcial de variáveis
isempty — verifica se uma variável é uma matriz vazia ou uma lista
vazia
isequal — tests the strict global equality between several objects, without equivalences
modulo — Resto módulo m com o sinal do operando esquerdo, ou de uma divisão polinomial
ndims — número de dimensões de um array
|, || — Binary OR between integers. Logical OR over/between booleans and numbers
size — tamanho de objetos
sub2ind — converte matriz de valores subescrtos para índice
linear
Linear Algebra
Eigenvalue and Singular Value
balanc — balanceamento de uma matriz ou de um feixe de
matrizes
bdiag — diagonalização em blocos, autovetores
generalizados
eigs — calculates largest eigenvalues and eigenvectors of matrices
pbig — autoprojeção
projspec — operadores espectrais
psmall — projeção espectral
spec — autovalores, e autovetores de uma matriz ou feixes
sva — aproximação em valores singulares
svd — decomposição em valores singulares
Factorization
chol — Cholesky factorization
fullrf — fatoração de posto completo (ou cheio)
fullrfk — fatoração de posto completo de A^k
hess — forma de Hessenberg
lu — fatores LU de eliminação Gaussiana
polar — Decomposição polar de uma matriz quadrada
qr — QR decomposição
rankqr — fatoração QR com revelação do posto
schur — decomposição (ordenada) de Schur de matrizes e
feixes
sqroot — fatoração hermitiana W*W'
Kernel
colcomp — compressão de colunas, núcleo
im_inv — imagem inversa
kernel — núcleo de uma matriz
range — Imagem (gerado) de A^k
rowcomp — compressão de linhas, imagem
Linear Equations
aff2ab — Conversão de uma função linear (afim) para forma
A,b
inv — inversa de uma matriz
linsolve — solucionador de equações lineares
lsq — Solução de A*X=B de mínimos quadrados lineares, com norm(X) mínima
pinv — pseudo-inversa
Markov Matrices
classmarkov — classes transientes e recorrentes da matriz de
Markov
eigenmarkov — Autovetores esquerdo e direito normalizados de
Markov
genmarkov — gera uma matriz de Markov aleatória com classes recorrentes e
transientes
Matrix Analysis
cond — número de condicionamento de uma matriz
det — determinant of a square matrix
orth — base ortogonal
rank — posto
rcond — número de condicionamento inverso
rref — computa a matriz-linha reduzida a forma escada por
transformações de LU
trace — traço de uma matriz
Matrix Pencil
companion — matriz companheira
ereduc — computa de forma escada de colunas da matriz por
transformações qz
fstair — computa a forma escada de feixe de colunas por transformações
qz
glever — inverso do feixe de matrizes
kroneck — forma de Kronecker de feixe de matrizes
lyap — equação de Lyapunov
pen2ea — conversão de feixe em matrizes E e A
pencan — forma canônica de feixe de matrizes
penlaur — Laurent coefficients of matrix pencil
quaskro — forma quasi-Kronecker
randpencil — feixe aleatório
rowshuff — algoritmo de embaralhamento
State-Space Matrices
coff — resolvente (método do cofator)
nlev — algoritmo de Leverrier
Subspaces
spaninter — interseção de subespaços
spanplus — soma de subespaços
spantwo — soma e interseção de subespaços
givens — transformação de Givens
householder — Householder orthogonal reflexion matrix. Symetrical wrt a plane
proj — projeção
Interpolação
bezier — compute the points for the bezier curve
bsplin3val — função de avaliação de derivada arbitrária de spline
3d
cshep2d — bidimensional cubic shepard (scattered)
interpolation
eval_cshep2d — avaliação por interpolação cúbica bidimensional de
Shepard
interp — função de avaliação de spline cúbico
interp1 — 1D interpolation in nearest, linear or spline mode
interp2d — função de avaliação spline bicúbica (2d)
interp3d — função de avaliação spline 3d
interpln — interpolação linear
linear_interpn — interpolação linear n-dimensional
lsq_splin — ajuste ponderado por spline cúbico de mínimos
quadrados
mesh2d — Triangulation of n points in the plane
smooth — suavização por funções splines
splin — interpolação por spline cúbico
splin2d — interpolação por spline bicúbico em grides 2d
splin3d — interpolação spline em grides 3d
CACSD
Control Design
Control Loop
augment — augmented plant
feedback — feedback operation
lft — linear fractional transformation
H-infinity
ccontrg — Central H-infinity continuous time controller
dhinf — H_infinity design of discrete-time systems
dhnorm — discrete H-infinity norm
gamitg — H-infinity gamma iterations for continuous time systems
h2norm — H2 norm of a continuous time proper dynamical system
h_cl — closed loop matrix
h_inf — Continuous time H-infinity (central) controller
h_inf_st — static H_infinity problem
h_norm — H-infinity norm
hinf — H_infinity design of continuous-time systems
linf — infinity norm
linfn — infinity norm
macglov — Continuous time dynamical systems Mac Farlane Glover problem
nehari — Nehari approximant of continuous time dynamical systems
parrot — Parrot's problem
Linear Quadratic
fourplan — augmented plant to four plants
gcare — Continuous time control Riccati equation
gfare — Continuous time filter Riccati equation
leqr — H-infinity LQ gain (full state)
lqe — linear quadratic estimator (Kalman Filter)
lqg — LQG compensator
lqg2stan — LQG to standard problem
lqg_ltr — LQG with loop transform recovery
lqi — Linear quadratic integral compensator (full state)
lqr — LQ compensator (full state)
Pole Placement
kpure — continuous SISO system limit feedback gain
krac2 — continuous SISO system limit feedback gain
ppol — pole placement
stabil — stabilization
ddp — disturbance decoupling
gfrancis — Francis equations for tracking
Identification
arl2 — SISO model realization by L2 transfer approximation
armax — armax identification
armax1 — armax identification
findABCD — discrete-time system subspace identification
findAC — discrete-time system subspace identification
findBD — initial state and system matrices B and D of a discrete-time system
findBDK — Kalman gain and B D system matrices of a discrete-time system
findR — Preprocessor for estimating the matrices of a linear time-invariant dynamical system
findx0BD — Estimates state and B and D matrices of a discrete-time linear system
imrep2ss — state-space realization of an impulse response
inistate — Estimates the initial state of a discrete-time system
lin — linearization
sident — discrete-time state-space realization and Kalman gain
sorder — computing the order of a discrete-time system
time_id — SISO least square identification
Linear Analysis
Controllability Observability
abinv — AB invariant subspace
cainv — Dual of abinv
cont_mat — controllability matrix
contr — controllability, controllable subspace, staircase
contrss — controllable part
ctr_gram — controllability gramian
dt_ility — detectability test
obs_gram — observability gramian
obscont — observer based controller
observer — observer design
obsv_mat — observability matrix
obsvss — observable part
ui_observer — unknown input observer
unobs — unobservable subspace
Frequency Domain
black — diagrama de Black (carta de Nichols)
bode — Bode plot
bode_asymp — Bode plot asymptote
calfrq — frequency response discretization
dbphi — frequency response to phase and magnitude representation
freq — frequency response
freson — peak frequencies
gainplot — esboço de magnitude
hallchart — Draws a Hall chart
nicholschart — Nichols chart
nyquist — diagrama de Nyquist
nyquistfrequencybounds — Computes the frequencies for which the nyquist locus enters and leaves a given rectangle.
phasemag — phase and magnitude
computation
phaseplot — frequency phase plot
repfreq — frequency response
svplot — singular-value sigma-plot
trzeros — transmission zeros and normal rank
Stability
bstap — hankel approximant
dtsi — Continuous time dynamical systems stable anti-stable decomposition
evans — lugar geométrico das raízes Evans
g_margin — gain margin and associated crossover frequency
p_margin — phase margin and associated crossover frequency
plzr — Esboço de pólo-zero
routh_t — tabela de Routh
sgrid — esboça linhas de grid de um s-plano
show_margins — display gain and phase margin and associated crossover frequencies
st_ility — stabilizability test
zgrid — esboçode um z-grid
Time Domain
arsimul — armax simulation
csim — simulation (time response) of linear system
damp — Natural frequencies and damping factors.
dsimul — state space discrete time simulation
flts — time response (discrete time, sampled system)
ltitr — discrete time response (state space)
narsimul — armax simulation (using rtitr)
rtitr — discrete time response (transfer matrix)
sensi — sensitivity functions
Linear System Factorization
colinout — inner-outer factorization
copfac — right coprime factorization of continuous time dynamical systems
dcf — double coprime factorization
fspec — spectral factorization of continuous time dynamical systems
fspecg — stable factorization of continuous time dynamical systems
fstabst — Youla's parametrization of continuous time linear dynamical systems
gtild — tilde operation
lcf — Continuous time dynamical systems normalized coprime factorization
rowinout — inner-outer factorization
specfact — spectral factor
sysfact — system factorization
Linear System Representation
abcd — state-space matrices
arma — Scilab arma library
arma2p — extract polynomial matrices from ar representation
arma2ss — transform an armax data structure into state space
representation.
armac — Scilab description of an armax process
bloc2ss — conversão de diagrama de blocos para espaço de estados
cont_frm — transfer to controllable state-space
des2ss — descriptor to state-space
des2tf — descriptor to transfer function conversion
frep2tf — transfer function realization from frequency response
lsslist — definição de função linear de espaço de estados do
Scilab
markp2ss — Markov parameters to state-space
pfss — partial fraction decomposition
pol2des — conversão de matrizes de polinômios para formas
descritoras
sm2des — system matrix to descriptor
sm2ss — system matrix to state-space
ss2des — (polynomial) state-space to descriptor form
ss2ss — state-space to state-space conversion, feedback,
injection
ss2tf — conversion from state-space to transfer function
ss2zp — SIMO state space system to zero pole gain representation
ssprint — embelezador de sistemas lineares
ssrand — gerador de sistema randômico
sysconv — conversão de sistema
syslin — definição de sistemas lineares
syssize — size of state-space system
systmat — matriz sistema
tf2des — transfer function to descriptor
tf2ss — transfer to state-space
tf2zp — SIMO transfer function to zero pole gain representation
trfmod — exibição de zeros e pólos
zp2ss — Zero pole gain to state space
zp2tf — Zero pole gain to transfer function
zpk — Zero pole gain system representation
zpk2ss — Zero pole gain to state space
zpk2tf — Zero pole gain to transfer function
Matrix Computation
linmeq — Sylvester and Lyapunov equations solver
mucomp — mu (structured singular value) calculation
ricc — Riccati equation
riccati — Solves the matricial Riccati equation (continuous | discrete time domain)
signm — função do sinal da matriz
sylv — Resolver as equações de Sylvester A*X + X*B = C ou A*X*B + X = C
Model Transformation
arhnk — Hankel norm approximant
balreal — balanced realization
bilin — general bilinear transform
canon — canonical controllable form
cls2dls — bilinear transform
colregul — removing poles and zeros at infinity
dscr — discretization of linear system
equil — balancing of pair of symmetric matrices
equil1 — balancing (nonnegative) pair of matrices
hankelsv — Hankel singular values
invsyslin — system inversion
minreal — minimal balanced realization
minss — minimal realization
projsl — linear system projection
rowregul — removing poles and zeros at infinity
zeropen — zero pencil
Polinômios
bezout — Maior Comum Divisor de dois polinômios ou dois inteiros, pelo método Bezout
chepol — Chebychev polynomials
cmndred — forma de denominador comum
coeff — coeficientes de matrizes de polinômios
coffg — matriz inversa de polinômios
colcompr — compressão de colunas de matrizes de polinômios
degree — grau da matriz de polinômios
derivat — derivada de matriz de razões de polinômios
determ — determinante de matrizes de polinômios
detr — determinante de uma matriz de razões de polinômios
diophant — Solves the diophantine (Bezout) equation p1*x1 + p2*x2 = b
factors — fatoração em ℝ de um polinômio ou uma fração racional
hermit — forma hermitiana
horner — avaliação polinomios ou razões de polinômios
hrmt — máximo divisor comum de polinômios
htrianr — triangularização de matrizes de polinômios
inv_coeff — constrói uma matriz de polinômios a partir de seus
coeficientes
invr — inversão de matrizes (de razões de polinômios)
lcmdiag — fatoração diagonal por MMC
ldiv — divisão longa entre matrizes de polinômios
pdiv — divisão polinomial
pol2str — conversão de polinômio para string
polfact — fatores reais mínimos de um polinômio
poly — Polynomial definition from given roots or coefficients, or characteristic to a square matrix.
polyDisplay — set or get the display mode of polynomials
polyint — Polynomial integration
residu — resíduo
roots — raízes de um polinômio
rowcompr — compressão de linhas de uma matriz de polinômios
sfact — fatoração espectral em tempo discreto
simp — simplificação racional
simp_mode — modifica o modo de simplificação racional
sylm — matriz de Sylvester
varn — variável simbólica de polinômios ou de frações racionais
Processamento de Sinais
Convolution - Correlation
conv — discrete 1-D convolution.
conv2 — discrete 2-D convolution.
convol — convolution
convol2d — discrete 2-D convolution, using fft.
corr — correlation, covariance
hank — covariance to hankel matrix
xcorr — Computes discrete auto or cross correlation
Filters
How to design an elliptic filter — How to design an elliptic filter (analog and
digital)
analpf — create analog low-pass filter
buttmag — Power transmission of a Butterworth filter
casc — cascade realization of filter from coefficients (utility function)
cheb1mag — response of Chebyshev type 1 filter
cheb2mag — response of type 2 Chebyshev filter
ell1mag — magnitude of elliptic filter
eqfir — minimax approximation of FIR filter
eqiir — Design of iir filters
faurre — filter computation by simple Faurre algorithm
ffilt — coefficients of FIR low-pass
filt_sinc — samples of sinc function
filter — filters a data sequence using a digital filter
find_freq — parameter compatibility for elliptic filter design
frmag — magnitude of FIR and IIR filters
fsfirlin — design of FIR, linear phase filters, frequency sampling technique
group — group delay for digital filter
hilbert — Discrete-time analytic signal computation of a real signal using Hilbert transform
iir — iir digital filter
iirgroup — group delay Lp IIR filter optimization
iirlp — Lp IIR filter optimization
kalm — Kalman update
lev — Yule-Walker equations (Levinson's algorithm)
levin — Toeplitz system solver by Levinson algorithm
(multidimensional)
lindquist — Lindquist's algorithm
remez — Remez exchange algorithm for the weighted chebyshev
approximation of a continuous function with a sum of cosines.
remezb — Minimax approximation of magnitude response
sgolay — Savitzky-Golay Filter Design
sgolaydiff — Numerical derivatives computation using Savitzky-Golay filter.
sgolayfilt — Filter signal using Savitzky-Golay Filter.
srfaur — square-root algorithm
srkf — square root Kalman filter
sskf — steady-state Kalman filter
syredi — Design of iir filters, syredi code interface
system — observation update
trans — low-pass to other filter transform
wfir — linear-phase FIR filters
wfir_gui — Graphical user interface that can be used to interactively design wfir filters
wiener — Wiener estimate
wigner — 'time-frequency' wigner spectrum
window — compute symmetric window of various type
yulewalk — least-square filter design
zpbutt — Butterworth analog filter
zpch1 — Chebyshev analog filter
zpch2 — Chebyshev analog filter
zpell — lowpass elliptic filter
Identification
frfit — frequency response fit
lattn — recursive solution of normal equations
lattp — Identification of MA part of a vector ARMA process
mrfit — frequency response fit
phc — Markovian representation
rpem — Recursive Prediction-Error Minimization estimation
Spectral estimation
cepstrum — cepstrum calculation
cspect — two sided cross-spectral estimate between 2 discrete time signals using
the correlation method
czt — chirp z-transform algorithm
mese — maximum entropy spectral estimation
pspect — two sided cross-spectral estimate between 2 discrete time signals using
the Welch's average periodogram method.
Transforms
dct — Discrete cosine transform.
dst — Discrete sine transform.
fft — Direct or inverse Fast Fourier Transform of a vector, matrix, or hypermatrix
fft2 — two-dimension fast Fourier
transform
fftshift — rearranges the fft output, moving the zero frequency to the center of the spectrum
hilb — FIR approximation to a Hilbert transform filter
ifftshift — inverse of fftshift
bilt — bilinear or biquadratic transform SISO system given by a zero/poles representation
detrend — remove constant, linear or piecewise linear trend from a vector
intdec — Changes sampling rate of a signal
unwrap — unwrap a Y(x) profile or a Z(x,y) surface. Unfold a Y(x) profile
xcov — Computes discrete auto or cross covariance
FFTW
Funções Especiais
%k — Jacobi's complete elliptic integral of the first kind (vectorized)
airy — Airy functions of the first and second kind, and their derivatives
amell — função "am" de Jacobi
besseli — funções modificadas de Bessel do primeiro tipo (Iα ).
beta — função beta
calerf — computa funções de erro
dawson — Compute the Dawson (scaled imaginary error) function.
delip — Integral elíptica
dlgamma — derivada da função gammaln, função psi
ellipj — Jacobi elliptic functions
erf — função de erro
erfc — função de erro complementar
erfcx — função de erro complementar escalada
erfi — The imaginary error function.
erfinv — função inversa à função de erro
findm — for elliptic filter design
gamma — gamma function, complete or incomplete normalized
gammaln — o logaritmo (natural) da função gama
legendre — funções associadas de Legendre
sinc — função sinc (seno cardinal)
sincd — digital sinc function or Dirichlet kernel
Estatística
Cumulated Distribution Functions
binomial — probabilidades de distribuição binomial
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
Mean Central Tendency
center — center
geomean — geometric mean
harmean — harmonic mean : inverse of the inverses average (without zeros)
mean — mean of all values, or means along a given dimension
meanf — weighted mean of a vector or a matrix
median — median (row median, column median,...) of
vector/matrix/array entries
trimmean — trimmed mean of a vector or a matrix
wcenter — center and weight
Dispersion widths
iqr — interquartile range
mad — mean absolute deviation
stdev — standard deviation (row or column-wise) of vector/matrix entries
stdevf — standard deviation
strange — range
variance — variance (and mean) of a vector or matrix (or hypermatrix) of real or complex numbers
variancef — variance (and mean) of a vector or matrix of frequency-weighted real or complex numbers
Empirical distribution
cmoment — central moments of all orders
histc — computes the histogram of a simple series of data
moment — non central moments of all orders
perctl — computation of percentils
quart — computation of quartiles
tabul — frequency of values of a matrix or vector
Multivariate Correl Regress PCA
correl — correlation of two variables
cov — Sample covariance matrix
covar — covariance of two variables
pca — Computes principal components analysis with standardized variables
princomp — Principal components analysis
reglin — Linear regression
show_pca — Visualization of principal components analysis results
Data with Missing Values
nancumsum — This function returns
the cumulative sum of the values of a matrix
nand2mean — difference of the means of
two independent samples
nanmean — mean (ignoring Nan's)
nanmeanf — mean (ignoring Nan's) with a given frequency.
nanmedian — median of the values of a numerical vector or matrix
nanreglin — Linear regression
nanstdev — standard deviation (ignoring the NANs).
nansum — Sum of values ignoring NAN's
thrownan — Eliminates nan values
Hypothesis Testing
ftest — Fisher ratio
ftuneq — Fisher ratio for samples of unequal size.
Matrizes Esparsas
Sparse Decompositions
ludel — função utilitária usada com lufact
lufact — fatoração LU esparsa
luget — extração dos fatores LU esparsos
lusolve — solucionador de sistemas lineares esparsos
spchol — fatoração esparsa de Cholesky
Sparse Matrix Manipulation
issparse — tests whether the input is sparse encoded (numeric or boolean)
nnz — número de entradas não-nulas de uma matriz
speye — matriz identidade esparsa
spones — matriz esparsa
sprand — matriz esparsa randômica
spzeros — matriz nula esparsa
Sparse Matrix Conversion
adj2sp — converte forma de adjacência para matriz esparsa
full — conversão de matriz esparsa para cheia (completa)
sp2adj — converte uma matriz esparsa para forma de
adjacência
sparse — definição de matriz esparsa
spcompack — converte uma representação de adjacência comprimida em
representação de adjacência padrão
spget — recupera entradas de matriz esparsa
Sparse Jacobian computation
spCompHessian — Consruct a compressed Hessian engine from its sparsity pattern using column intersection graph coloring
spCompJacobian — Consruct a compressed Jacobian engine from its sparsity pattern using column intersection graph coloring
spyCol — Represent sparsity pattern of a matrix with column coloring
Linear Equations (Iterative Solvers)
conjgrad — conjugate gradient solvers
gmres — Generalized Minimum RESidual method
qmr — quasi minimal residual method with preconditioning
chfact — fatoração esparsa de Cholesky
chsolve — solucionador esparso de Cholesky
ordmmd — Compute multiple minimum degree ordering
Interfaces com UMFPACK (sparse)
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
PlotSparse — plot the pattern of non nul elements of a sparse matrix
ReadHBSparse — read a Harwell-Boeing sparse format file
res_with_prec — computes the residual r = Ax-b with precision
taucs_chdel — utility function used with taucs_chfact
taucs_chfact — cholesky factorization of a sparse s.p.d. matrix
taucs_chget — retrieve the Cholesky factorization at the scilab level
taucs_chinfo — get information on Cholesky factors
taucs_chsolve — solves a linear s.p.d. system A*X = B from Cholesky factors of the sparse A
umf_ludel — utility function used with umf_lufact
umf_lufact — lu factorization of a sparse matrix
umf_luget — retrieve lu factors at the Scilab level
umf_luinfo — get information on LU factors
umf_lusolve — solve a linear sparse system given the LU factors
umfpack — solve sparse linear system
Otimização e Simulação
XML Management
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
xmlDelete — Delete a XML document
xmlDocument — Create a new XML document
xmlDTD — Create a XML DTD object
xmlDump — Dump a XML object
xmlElement — Create a new XML element
xmlFormat — Format a Scilab variable into XML
xmlGetNsByHref — Get a namespace by its href
xmlGetNsByPrefix — Get a namespace by prefix
xmlGetOpenDocs — Get all open XML documents or all open XML Validation files.
xmlGetValues — Parses and gets values of chosen tags attributes in a XML file
xmlIsValidObject — Test the existence of a XML object
xmlName — Retrieve the name of the elements.
xmlNs — Create a new XML Namespace
XML Objects — Describe the properties of the different XML objects
xmlRead — Read a XML stream from a local or distant file
xmlReadStr — Read a XML tree from a string
xmlRelaxNG — Create a XML Relax NG object
xmlRemove — Remove an element or a list of elements from their parents
xmlSchema — Create a XML Schema object
xmlSetAttributes — Set the attributes name and value.
xmlSetValues — Sets some attribute=value in an XML document for a given tag/XPath
xmlValidate — Validate a document in using a DTD, a Relax NG or a Schema.
xmlWrite — Write a XML document in a file
xmlXPath — Make a XPath query on a XML document
HDF5 files
h5is* tests
h5isArray — Check if the HDF5 object is an array
h5isAttr — Check if the HDF5 object is an attribute
h5isCompound — Check if the HDF5 object is a compound object
h5isFile — Check if the HDF5 object is a file
h5isGroup — Check if the HDF5 object is a group
h5isRef — Check if the HDF5 object is a reference object
h5isSet — Check if the HDF5 object is a dataset
h5isSpace — Check if the HDF5 object is a dataspace
h5isType — Check if the HDF5 object is a type
h5isVlen — Check if the HDF5 object is a variable length array
h5attr — Create an attribute
h5close — Close a HDF5 object
h5cp — Copy an object
h5dataset — Create a dataset and write the data
h5dump — Dump the content of an H5 object on the standard output stream
h5exists — Test the existence of named object
h5flush — Flush all the buffers associated with a file
h5get — Get a named object
h5group — Create a group
h5label — Label a dataset
h5ln — Link an object to another one
h5ls — List the content of an HDF5 object (group or dataset)
h5mount — Mount a file on a group
h5mv — Move an object
H5 Objects — Describe the properties of the different H5 objects
h5open — Open an HDF5 file
h5read — Read the data of HDF5 dataset
h5readattr — Read the data of an HDF5 attribute
h5rm — Remove elements from an HDF5 file
h5umount — Unmount a previously mounted file.
h5write — Create a dataset (if it does not exist) and write the data
h5writeattr — Write an attribute in a group or a dataset
Arquivos : funções de Entrada/Saída
Directory
chdir — muda o diretório corrente do Scilab
createdir — makes new directory
dir — gets file list
isdir — checks that a path points to an existing directory
ls — shows files
mkdir — makes a new directory
pwd — gets Scilab current directory
removedir — removes a directory
rmdir — removes a directory
file_system
copyfile — copies a file
deletefile — deletes a file
fileinfo — Fornece informações sobre um arquivo
findfiles — finding all files with a given file specification
isfile — checks whether argument is an existing file
listfiles — list of files
mdelete — deletes file(s)
movefile — moves file or directory
newest — retorna o arquivo mais novo de um conjunto de
arquivos
Paths - Filenames
basename — strip directory and suffix from filenames
fileext — returns extension for a file path
fileparts — returns the path, filename and extension for a file path
filesep — returns directory separator for current platform
fullfile — builds a full filename from parts
fullpath — creates an full path name for the specified relative path name.
get_absolute_file_path — fornece o nome de endereço absoluto de um arquivo aberto no
Scilab
getdrives — gets the drive letters of all mounted filesystems on the computer
getlongpathname — gets long path name
getrelativefilename — dado um nome de diretório absoluto e um nome de arquivo
relativo, retorna um nome de arquivo relativo.
getshortpathname — gets short path name
is_absolute_path — checks if argument is an absolute path
pathconvert — converts a path to an OS path format.
pathsep — provides the path separator used in the PATH environment variable of the current OS.
splitURL — Split an URL (HTTP, HTTPS, FTP...)
tempname — creates a file with an unique filename
compress — Compress files in an archive
decompress — decompress files from an archive
dispfiles — displays properties of opened files
fprintfMat — writes a matrix in a file
fscanfMat — reads a matrix from a text file
getmd5 — retorna soma de verificação md5
getURL — Download an URL (HTTP, HTTPS, FTP...)
hash — get checksum of file or string using various digest algorithms
%io — protected variable providing ids of the standard input and standard output
listvarinfile — lists variables stored in a binary archive (names, types, sizes..)
mclearerr — resets binary file access errors
mclose — closes opened files
meof — checks if end of file has been reached
merror — tests the file access errors indicator
mfprintf — converts, formats, and writes data to a file
mfscanf — reads input from the stream pointer stream (interface to the C
fscanf function)
mget — parses numbers in a binary file and returns them as decimals
mgetl — reads lines from an text file
mgetstr — reads a character string from a file
mopen — opens files in Scilab
mput — writes byte or word in a given binary format
mputl — writes strings in a text file
mputstr — write a single text in an open file
mseek — sets current position in a binary file
mtell — Returns the offset of the current byte relative to the beginning of a file
save format — format of files produced by "save"
scanf — converts formatted input on standard input
scanf_conversion — mscanf, msscanf, mfscanf conversion specifications
Funções de Entrada/Saída
OS_commands
getenv — retorna o valor de uma variável de ambiente
getpid — Retorna o identificador do processo Scilab
host — executes a Windows, Linux, or MacOS command
scilab — run command or file in another Scilab
setenv — ajusta o valor de uma variável de ambiente
unix_g — executa algumas instruções do Windows, Linux ou MacOS, saída em variáveis
unix_s — executa silenciosamente algumas instruções do Windows, Linux ou MacOS
unix_w — executa algumas instruções do Windows, Linux ou MacOS, resulta no console do Scilab
unix_x — executar algumas instruções do Windows, Linux ou MacOS, resulta em uma janela
de mensagem pop-up
file — Gerenciamento de arquivos
getio — retorno de unidades lógicas de entrada/saída do
Scilab
load — Loads some archived variables, a saved graphic figure, a library of functions
read — Leitura de matrizes
save — Saves some chosen variables in a binary data file
write — escreve números reais ou strings no console ou em um arquivo formatado
Biblioteca de Gráficos
2d_plot
champ — esboço de campo vetorial 2d
champ_properties — Descrição das propriedades da entidade campo vetorial
2d
comet — 2D comet animated plot
contour2d — curvas de nível de uma superfície em um esboço 2d
contour2di — Computa curvas de nível em um esboço 2d
contour2dm — compute level curves of a surface defined with a mesh
contourf — Curvas de nível preenchidas de uma superfície em um esboço
2d
cutaxes — plots curves or an existing axes along a discontinuous or multiscaled axis
errbar — adiciona barras de erro veriticais a um esboço 2d
fchamp — campo direcional de uma EDO 2d de primeira ordem
fec — Esboço pseudo-colorido triangular de uma função definida por
uma malha triangular
fec properties — description of the fec entities
properties
fgrayplot — esboço 2d de uma superfície definida por uma função utilizando
cores
grayplot — esboço 2d de uma superfície utilizando-se cores
grayplot_properties — description of the grayplot entities properties
graypolarplot — Esboço polar 2d de uma superfície utilizando-se
cores
histplot — esboça um histograma
LineSpec — Customização rápida de linhas que aparecem em um
esboço
loglog — 2D logarithmic plot
Matplot — esboço 2d de uma matriz utilizando-se cores
Matplot1 — Esboço 2d de matrizes utilizando cores
Matplot properties — Description of the Matplot entities properties
paramfplot2d — Esboço animado 2d, curva definida por uma função
plot — Esboço 2d
plot2d — 2D plot
plot2d2 — esboço 2d (funções de degraus)
plot2d3 — esboço 2d (barras veticais)
plot2d4 — esboço 2d (setas)
plotimplicit — Plots the (x,y) lines solving an implicit equation or Function(x,y)=0
polarplot — Esboço de coordenadas polares
scatter — 2D scatter plot
semilogx — 2D semilogarithmic plot
semilogy — 2D semilogarithmic plot
Sfgrayplot — esboço 2d suave de uma superfície definida por uma função
utilizando cores
Sgrayplot — esboço 2d suave de uma superfície utilizando
cores
stackedplot — plot multiple timeseries on time axis
3d_plot
bar3d — Gráfico de barras 3D
comet3d — 3D comet animated plot
contour — curvas de nível em uma superfície 3d
eval3dp — computa facetas 3d de uma superfície
parametrizada
fplot3d — esboço 3d de uma superfície definida por uma
função
fplot3d1 — Esboço 3d em escala de cinza ou colorido de nível de uma
superfície definida por uma função
genfac3d — computa facetas de uma superfície 3d
geom3d — projeção 3d para 2d após um esboço 3d
mesh — Esboço 3d de uma malha
nf3d — Facetas retangulares para parâmetros da função
plot3d
param3d — plots a single curve in a 3D cartesian frame
param3d_properties — description of the 3D curves entities properties
plot3d — esboço 3d de uma superfície
plot3d1 — Esboço 3d em níveis de cinza ou de cores de uma
superfície
plot3d2 — Esboço de superfície definida por facetas
retangulares
plot3d3 — Esboço de malha de uma superfície definida por facetas
retangulares
scatter3d — 3D scatter plot
secto3d — Conversão de superfícies 3d
surf — Esboço de superfície 3d
surface properties — description of the 3D entities
properties
annotation
captions — Impressão de legendas de gráficos
label_properties — Descrição de propriedades da entidade Label
(rótulo)
legend — Imprime uma legenda para o gráfico
legend_properties — Descrição das propriedades da entidade Legend
(legenda)
legends — Imprime uma legenda para o gráfico
title — displays a title above a graphic axes, or updates its properties.
xlabel — sets or updates the x-axis label or/and its properties
xtitle — adidciona títulos a janelas de gráficos
axes_operations
axes_properties — descrição das propriedades de entidades Axes (de eixos)
gca — Retorna o manipulador da entidade Axes corrente
gda — Retorna o manipulador dos eixos padrões.
isoview — tunes isometric rendering of graphical axes
newaxes — Cria uma nova entidade Axes (de eixos)
replot — reformula a área de exibição de um ou mais gráficos
rotate_axes — Rotação interativa de um manipulador Axes
sca — Ajusta a entidade de eixos corrente
sda — Redefine os eixos padrão para seus valores de fábrica
subplot — grids the current figure or frame, and sets the current axes to a chosen cell
unzoom — Diminui a ampliação
xgrid — add a grid on a 2D or 3D plot
xsetech — ajusta a sub-janela de uma janela de gráficos para
esboço
zoom_rect — Amplia uma seleção da figura gráfica corrente
axis
axis_properties — Descrição das propriedades da entidade Axis (eixo)
drawaxis — Desenha um eixo
graduate — graduação de eixos
xgraduate — Graduação de eixos
bar_histogram
bar — Histograma de barras
barh — Exibição horizontal de um histograma de barras
barhomogenize — Homogeniza todas as barras inclusas nos eixos correntes
Color management
Mapas de cores
colormap — set and/or get a figure colormap.
colormaps — mapa de cores
Predefined colormaps — Overview of predefined colormaps.
addcolor — adiciona cores novas ao mapa de cores corrente
color — Retorna o identificador de uma cor
color_list — Lista dos nomes das cores
colorbar — draws a vertical color bar
getcolor — abre um diálogo que exibe as cores no mapa de cores atual ou padrão
corrente
hsv2rgb — Converte cores HSV para RGB
name2rgb — Retorna valores RGB correspondentes ao nome da
cor
rgb2name — Retorna o nome de uma cor
uigetcolor — Opens a dialog for selecting a color.
Datatips
propriedades das datatips — Descição das propriedades para a entidade Datatip.
datatipCreate — Create a datatip on a polyline by program
datatipGetEntities — Get all the entities compatible with datatips in the given axes.
datatipManagerMode — Set or toggles the datatips mode.
datatipMove — Move a specified datatip using the mouse.
datatipRemove — Removes a selected datatip
datatipRemoveAll — Removes all datatips on a set of polylines.
datatips — Tool for placing and editing tips along the plotted curves
datatipSetDisplay — Set the function used to compute the datatip string.
datatipSetInterp — Set the interpolation mode for datatip.
datatipSetOrientation — Set the position of the text box associated with the given tip.
datatipSetStyle — Set the datatip style.
figure_operations
anti_aliasing — Figure's property smoothing the stair-like aspect when rendering curves
clf — Clears and resets a figure or a frame uicontrol
colordef — Set the color look-and-feel of a given or of all forthcoming graphic figures
drawlater — Torna galhos dos eixos invisíveis.
drawnow — Desenha entidades gráficas escondidas
figure properties — description of the graphics
figure entity properties
gcf — Retorna o manipulador da janela GUI ou de gráficos
corrente.
gdf — Retorna o manipulador da figura corrente
pixel_drawing_mode — Figure's property setting the RGBwise pixels update mode when drawing
scf — Ajusta a (janela) de figura gráfica corrente
sdf — Ajusta figura padrão
show_window — Restaura uma janela de gráficos
winsid — retorna a lista de janelas de gráficos
geometric_shapes
arc_properties — Descrição das propriedades da entidade Arc (arco)
rectangle_properties — Descrição de propriedades da entidade Rectangle
(retângulo)
Segments properties — description of the Segments entity properties
xarc — esboça parte de uma elipse
xarcs — desenha partes de um conjunto de elipses
xarrows — desenha um conjunto de setas
xfarc — preenche parte de uma elipse
xfarcs — preenche partes de um conjunto de elipses
xfrect — preenche um retângulo
xrect — desenha um retângulo
xrects — desenha ou preenche um conjunto de retângulos
xsegs — desenha segmentos desconexos
handle
copy — Copia uma entidade de gráficos
delete — Deleta uma entidade gráfica e seus galhos
gce — Retorna o manipulador da entidade corrente
ged — Editor Gráfico do Scilab
glue — Cola um conjunto de entidades gráficas em um Compound
("composto")
is_handle_valid — Verifica se um conjunto de manipuladores gráficos ainda é
válido
swap_handles — Permuta dois manipuladores em uma hierarquia
gráfica
unglue — Descola uma objeto Compound e o substitui por um galho
individual
interaction
dragrect — Arrasta retângulos com o mouse
edit_curv — interactive modal (blocking) graphic curve editor
event handler functions — Protótipo de funções que podem se utilizadas como
gerenciadoras de eventos
locate — mouse selection of a set of points in a 2D axes
rubberbox — Caixa tipo liga de borracha para seleção de um
retângulo
seteventhandler — Define um gerenciador de eventos para uma janela
gráfica
twinkle — Faz uma entidade gráfica piscar
xclick — espera por um clique do mouse
xgetmouse — retorna os eventos de mouse e posição corrente
load_save
xload — displays in a given window some graphical component loaded from a file.
xsave — salva gráficos em um arquivo
polygon
polyline properties — description of the Polyline
entity properties
xfpoly — preenche um polígono
xfpolys — preenche um conjunto de polígonos
xpoly — desenha uma poligonal ou um polígono
xpolys — desenha um conjunto de poligonais ou polígonos
xrpoly — desenha um polígono regular
property
get — Gets the handle of a graphical or User Interface object, or the property's value of objects.
set — Ajusta um valor de propriedade de uma objeto entidade gráfica
ou de um objeto Interface do Usuário (User Interface)
text
graphics_fonts — Descrição de fontes utilizadas em figuras
gráficas
Math rendering in Scilab graphics — Display mathematical equations in Scilab graphics through the
LaTeX or MathML languages.
stringbox — Computa o retângulo de fronteira de um texto ou
rótulo.
text properties — description of the Text entity properties
titlepage — adiciona título no meio de uma janela de gráficos
xlfont — carrega uma fonte em um contexto gráfico ou pergunta a
fonte carregada
xnumb — Imprime números
xstring — imprime strings
xstringb — escreve strings em uma caixa
xstringl — computa uma caixa que cerca strings
transform
move — Move uma entidade gráfica e seus galhos.
orthProj — Computes the orthogonal projection of a point to a polyline in the plane.
rotate — rotação de um conjunto de pontos
scaling — transformação afim de um conjunto de pontos
lighting
light — creates a light object in the given axes
light properties — Light overview
lighting — Lighting overview
Compound properties — description of the Compound entity properties
GlobalProperty — Customização de aparência dos objetos (curvas, superfícies...)
num comando plot ou surf.
Graphics — Resumo da biblioteca de gráficos
graphics_entities — Descrição das estruturas de dados de entidades
gráficas
object_editor — Descrição das capacidades do editor de objetos
gráficos
pie — Desenha um gráfico de torta
multiscaled plots — How to set several axes for one curve or for curves with distinct scales
xchange — conversão de coordenadas reais para coordenadas
pixeis
Gráficos : exportando
driver — seleciona um driver gráfico
xend — termina uma sessão de gráficos
xinit — inicialização de um driver de gráficos
xs2bmp — envia gráficos para um arquivo em sintaxe BMP
xs2emf — envia gráficos para um arquivo em sintaxe EMF (apenas para
Windows)
xs2eps — salva gráficos em um arquivo Postscript
xs2gif — envia gráficos a um arquivo em sintaxe GIF
xs2jpg — envia gráficos a um arquivo em sintaxe JPG
xs2pdf — salva gráficos a um arquivo PDF
xs2png — envia gráficos a um arquivo em sintaxe PNG
xs2ppm — envia gráficos para um arquivo em sintaxe PPM
xs2ps — envia gráficos a um arquivo em sintaxe PS
xs2svg — Salva gráficos em um arquivo SVG
IGU
Estruturas de Dados
cells
cell — cria um cell (célula) de matrizes vazias
cell2mat — converte um cell array (array de células) em uma
matriz
iscell — verifica se um array é um cell (célula)
makecell — Creates a cell array.
num2cell — converts an array into a cell array
bool2s — converte uma matriz de valores booleanos para uma matriz de
valores 0 ou 1
definedfields — retorna o índice dos campos definidos de uma
lista
fieldnames — get a tlist, mlist or struct fields names
getfield — extração de campos de listas
isfield — checks if the given fieldname exists in a structure or mlist or tlist
isstruct — checa se uma variável é um struct array
(estrutura)
list — objeto do Scilab e definição de lists ("listas")
list2vec — Concatenates list entries in a matrix.
lstcat — concatenação de listas
mlist — objeto Scilab, definição de listas com tipos orientadas
matricialmente
null — deletes a list component or a field of a structure, Mlist, or Tlist
rlist — definição de função racional do Scilab
setfield — altera o valor de um elemento de uma mlist, tlist ou list
struct — Builds a structure or an array of structures
tlist — objeto do Scilab e definição de listas com tipos ("typed
lists")
tree_show — Displays a tree view of a list, tlist, mlist, cell or structure array, Xcos block
vec2list — Inverse function of list2vec.
Parâmetros
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
Cadeias de Caracteres (Strings)
ascii — conversão ASCII de strings
blanks — cria strings de caracteres em branco
char — função char
convstr — conversão maiúsculas-minúsculas,
minúsculas-maiúsculas
emptystr — string de comprimento zero
evstr — avaliação de expressões
grep — acha correspondências de um string em um vetor de
strings
isalphanum — verifica se os caracteres de um string são
alfanuméricos
isascii — Testa se cada caractere de strings fornecidas é do tipo 7-bit US-ASCII
isdigit — checa se os caracteres de um string são números entre 0 e 9
isletter — verifica se os caracteres de um string são letras do
alfabeto
isnum — testa se um string representa um número
justify — Alinha o texto em cada coluna completada com espaços, à esquerda, ao centro ou à direita
length — Número de caracteres de um texto. Número de elementos de uma matriz ou lista.
part — extração de strings
prettyprint — Converts a Scilab object into some corresponding LaTeX, TeX, MathML or HTML strings
regexp — em uma string, localize (e extraia) substrings correspondentes a uma expressão regular
sci2exp — returns a string able to generate a given Scilab object
strcat — concatena strings
strchr — acha a primeira ocorrência de um caractere em um
string
strcmp — compara strings
strcspn — comprimentos do início dos textos até que um caractere entre aqueles proibidos
strindex — procura posição de um string em outro
string — conversão para string (cadeia de caracteres)
stripblanks — retira espaços em branco (e tabulações) no início ou no fim de
strings
strncpy — Obtém e fornece os N primeiros caracteres dos textos fornecidos
strrchr — acha a última ocorrência de um caractere em um
string
strrev — retorna um string invertido
strsplit — split a single string at some given positions or patterns
strspn — comprimentos do início dos textos, desde que os caracteres estejam entre os permitidos
strstr — localiza sub-strings
strsubst — substitui um string por outro dentro de um string
strtod — parse and convert literal numbers STRings TO Decimal numbers
strtok — divide um string em fichas (tokens)
tokenpos — retorna as posições das fichas (token) em um
string
tokens — Divide um texto usando separadores e fornece seus pedaços
Manipulação de Arquivos de Som
analyze — frequency plot of a sound signal
auread — load .au sound file
auwrite — writes .au sound file
beep — Produce a beep sound
lin2mu — linear signal to mu-law encoding
loadwave — load a sound wav file into scilab
mapsound — Computes and displays an Amplitude(time, frequency) spectrogram of a sound record
mu2lin — mu-law encoding to linear signal
playsnd — command-line sound player facility
savewave — save data into a sound wav file.
sound — Obsolete . Please use playsnd(…) instead
wavread — reads sound data or querries data info from a .wav audio file
wavwrite — writes .wav sound file
Data e Hora
caldays — create a calendarDuration in days
calendar — Calendar of a given month and year (Gregorian dates)
calendarDuration — create a calendarDuration - duration in days, months and years
clock — Return the current Gregorian datetime and international time zone of the computer's clock
date — retorna string contendo a data corrente
datenum — Convert to serial date number
datetime — create points in time
datevec — Date components
duration — create a duration - duration in hours, minutes and seconds
eomday — Return last day of month
etime — tempo decorrido
getdate — Current datetime or POSIX timestamp from computer's clock. Datetimes from given timestamps
hours — convert reals in hours (duration)
isnat — check if a variable contains "Not a Time" values
NaT — Not a Time function used to create empty datetime
now — Return current date under the form of a Unix hour (timestamp)
realtimeinit — sets the time unit
sleep — suspend all code executions (console, scripts, callbacks,..)
tic — inicia um cronômetro
timer — cpu time
toc — lê o cronômetro
weekday — Day's index and name in its week for given dates
Funções de Saída
disp — exibição de variáveis
mprintf — converts, formats, and writes data to the main scilab window
msprintf — converts, formats, and writes data in a string
print — imprime variáveis em um arquivo
printf_conversion — Especificações de conversão de mprintf, msprintf,
mfprintf
Xcos
Planilhas
Console
ans — resposta
clc — Clear Command Window
completion — returns files or variables names or reserved keywords starting as a given text
console — Keyboard shortcuts predefined in the console window
diary — diary of session
input — prompts the user for keyboard input
lines — sets and queries the display width and pagination for the console
mode — sets or queries the mode echoing Scilab instructions in the console
%onprompt — special custom function called after each line execution in console
prompt — Get/Set current prompt
tohome — Clears the command window by masking its former content above the top
Gerenciador de histórico
Matlab : Arquivos de dados (R/W)
Code Matlab => Scilab
Funções
Built-in & external
clearfun — remove função primitiva
external — objeto Scilab, função ou rotina externa
funptr — codificação de primitivas
intppty — ajusta propriedades de passagem de argumentos de
interface
newfun — adiciona um nome à tabela de funções
what — lista de primitivas do Scilab
Libraries
genlib — builds a library from a set of *.sci files defining functions in a given directory
get_function_path — retorna o endereço do arquivo fonte de uma função de
biblioteca
lib — loads a library of Scilab functions and variables, and sets its name
librarieslist — retorna as bibliotecas do Scilab
libraryinfo — retorna macros e endereço de uma biblioteca Scilab
argn — número de argumentos na chamada de uma função
deff — in-line definition of a (anonymous) function in Scilab language
exec — script file execution
execstr — execute Scilab code in strings
feval — múltipla avaliação
funcprot — alterna o modo de proteção de funções Scilab
function — abre definição de função
getd — retorna todas as funções definidas em um
diretório
macr2tree — fornece o código interno de uma função Scilab compilada
macro — Procedimento Scilab e objeto Scilab
macrovar — variáveis de uma função
overloading — capacidades de overloading ("sobrecarga") de exibições,
funções e operadores
tree2code — gera a definição ASCII de uma função Scilab
varargin — variável do número de argumentos de saída em uma lista de
argumentos de entrada
varargout — variável do número de argumentos de saída em uma lista de
argumentos de saída
whereis — Returns the name of the loaded library/module a given function belongs to
Ferramentas de Desenvolvimento
Ferramentas de Demonstração
Link Dinâmico/incremental
addinter — new functions interface dynamic link at run time.
c_link — check if symbol loaded with dynamic link
call — chamada a rotinas de usuário FORTRAN ou C
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
G_make — call make or nmake
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_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_gen_Make — utility for ilib_build: produces a Makefile for building shared libraries
ilib_include_flag — Return a formatted includes related string to pass to
system compiler
ilib_mex_build — utility for mex library management
ilib_verbose — set level of display used by dynamic link
functions.
link — dynamic linker
Supported and compatible compilers — supported and compatible compilers by Scilab
ulink — unlink/unload a dynamically linked shared object
ATOMS
Interfaces com Tcl/Tk
Script editor
edit — edição de funções
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
Gerenciamento de ajuda online
utilities
%helps — variável definindo o endereço dos diretórios de ajuda
add_help_chapter — adiciona uma entrada na lista de ajudas
del_help_chapter — Delete an entry in the help list
help_from_sci — Geração de arquivos de ajuda e de arquivos de demonstração a
partir da seção de comentários de cabeçalho de um arquivo-fonte
.sci
help_skeleton — constrói o esqueleto do arquivo de ajuda xml associado à
função Scilab
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 — editando item do manual
xmltohtml — converte arquivos de ajuda xml do Scilab para formato
HTML
xmltojar — converte arquivos de ajuda xml do Scilab para formato
javaHelp
xmltopdf — converte arquivos de ajuda xml do Scilab para formato
PDF
xmltops — converte arquivos de ajuda xml do Scilab para formato
Postscript
apropos — procura por palavras-chave na ajuda do Scilab
head_comments — exibe comentários do cabeçalho da função Scilab
help — queries and displays help pages in the Scilab help browser
Modules manager
Localização
addlocalizationdomain — add a new domain in localization mechanism.
getdefaultlanguage — returns the default language used by Scilab
getlanguage — returns the current language used by Scilab.
gettext — indexes or/and translates some indexed english messages
setdefaultlanguage — sets the language of the session at startup and for some fixed Scilab menus
setlanguage — chooses the language used for standard messages and help pages for the current session
API Scilab
call_scilab API
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
DisableInteractiveMode — Disables some features (plotting, gui creation, Tcl/Tk...) and
leaves only the computing engine
ExecScilabCommand — Execute a Scilab from a C/C++ code (call_scilab) and can get message and callstack on error.
fromc — Checks if current Scilab is called from an external C program (by StartScilab).
fromjava — Checks if current Scilab is called from javasci
GetLastJob — Returns the latest job sent to Scilab engine
ScilabHaveAGraph — Check if any Scilab graphics have been opened.
SendScilabJob — Send a Scilab task from a C/C++ code
(call_scilab)
SendScilabJobs — Send Scilab tasks from a C/C++ code (call_scilab)
StartScilab — Initializes and starts Scilab engine in Call
Scilab
TerminateScilab — Stops and terminates Scilab engine in Call Scilab
JVM
Java from Scilab
Getting started - Beginning — How to use the Java Scilab binding?
Getting started - Second step — How to use the Java Scilab binding?
jallowClassReloading — Allow the class reloading
jarray — Create a Java array
jautoTranspose — Set the way to convert matrices
jautoUnwrap — Unwrap automatically returned values
jcast — Cast a Java object into another one.
jcompile — Compile Java code or file
jcreatejar — Creates a Java ARchive (JAR) from a set of files / directories
jdeff — Map a static Java method onto a Scilab macro
jdisableTrace — Stop the trace process.
jenableTrace — Allow to trace the internal functionality of JIMS to help the debugging.
jexists — Test if a Scilab Java Object is valid on the Java side
jgetclassname — Return the class name of the given object
jgetfield — Get the field value of a Java object
jgetfields — Get all the fields of a Java object
jgetinfo — Returns information about the Java virtual machine
jgetmethods — Get all the methods of a Java object
jimport — Import a Java class
jinvoke — Invoke a method of a Java object
jinvoke_db — Invoke a method of a Java object in using Java direct buffers
jnewInstance — Creates a new instance of a Java class
jnull — The Scilab version of the Java null object.
jremove — Remove a Java Object on the Java side
jsetfield — Set the field of a Java object
junwrap — Convert a Java object into a Scilab native type
junwraprem — Convert a Java object into a Scilab native type and remove it from the Java side
jvoid — For no argument functions
jwrap — Wrap a Scilab variable into a Java one if possible
jwrapinchar — Wrap Scilab uint16 matrix into Java char multiarray.
jwrapinfloat — Wrap Scilab double matrix into Java float multiarray.
new — Creates a new instance of a Java class
Interface Java
Preferences
Coverage
covMerge — Merges coverage results and exports to a file
covStart — Instruments some macros to store runtime information on code coverage and
execution time
covStop — Removes all instrumentation data
covWrite — Exports runtime performance results to HTML and binary files
profile — General information about instrumentation capabilities
profileDisable — Remove instrumentation from a function, a library or remove all instrumentation
profileEnable — Add instrumentation to a function, a library or all available functions
profileGetInfo — Retrieve instrumentation information as a Scilab value
Lint tool (SLint)
Web Tools
Ferramentas Windows
consolebox — shows or hides the MS Windows terminal running the Scilab session
createGUID — Creates a GUID (Windows only)
dos — executes some DOS instructions (Windows only)
findfileassociation — Searches for and retrieves a file association-related string from the registry (Windows only)
getsystemmetrics — Retrieves the specified system metric or system configuration
setting (Windows only)
istssession — Determines if scilab is launched from a ms terminal service session (Windows only)
mcisendstring — sends a command string to an MCI
device (Windows only)
powershell — executes a command with the Windows powershell interpreter (Windows only)
win64 — Determine whether Windows x64 version of Scilab (Windows only)
winopen — Open file in appropriate application
(Windows only)
winqueryreg — Get item from Microsoft Windows
registry (Windows only)