Matlab Referenz mit Details
Zur Navigation springen
Zur Suche springen
Inhaltsverzeichnis
Special Pages
Arithmetic Operators + - * / \ ^ '
Relational Operators < > <= >= == ~=
Logical Operators: Elementwise & | ~
Logical Operators: Short-circuit && ||
Special Characters [ ] ( ) {} = ' . ... , ; : % ! @
a
accumarray | Construct an array with accumulation |
abs | Absolute value and complex magnitude |
acos | Inverse cosine, result in radians |
actxcontrol | Create ActiveX control in figure window |
acosd | Inverse cosine, result in degrees |
acosh | Inverse hyperbolic cosine |
acot | Inverse cotangent, result in radians |
acotd | Inverse cotangent, result in degrees |
acoth | Inverse hyperbolic cotangent |
acsc | Inverse cosecant, result in radians |
acscd | Inverse cosecant, result in degrees |
acsch | Inverse cosecant and inverse hyperbolic cosecant |
actxcontrolselect | Display graphical interface for creating an ActiveX control |
actxcontrollist | List all currently installed ActiveX controls |
arithmeticoperators | Matrix and array arithmetic |
actxserver | Create COM Automation server |
addframe | Add frame to Audio/Video Interleaved (AVI) file |
addpath | Add directories to MATLAB search path |
addpref | Add preference |
addproperty | Add custom property to object |
addtodate | Modify date number by field |
airy | Airy functions |
alim | Set or query the axes alpha limits |
all | Determine if all array elements are nonzero |
allchild | Find all children of specified objects |
alpha | Set transparency properties for objects in current axes |
alphamap | Specify the figure alphamap (transparency) |
ancestor | Get ancestor of graphics object |
and | Find logical AND of array or scalar inputs |
angle | Phase angle |
annotation | Create annotation objects |
annotationdoublearrowproperties | Modifying Properties |
annotationarrowproperties | Modifying Properties |
annotationrectangleproperties | Modifying Properties |
annotationellipseproperties | Modifying Properties |
annotationlineproperties | Modifying Properties |
ans | The most recent answer |
any | Determine if any array elements are nonzero |
annotationtextarrowproperties | Modifying Properties |
annotationtextboxproperties | Modifying Properties |
area | Filled area 2-D plot |
asec | Inverse secant, result in radians |
areaseriesproperties | Modifying Properties |
arrayfun | Apply function to each element of array |
ascii | Set FTP transfer type to ASCII |
assignin | Assign value to variable in specified workspace |
asecd | Inverse secant, result in degrees |
asech | Inverse hyperbolic secant |
asin | Inverse sine, result in radians |
asind | Inverse sine, result in degrees |
asinh | Inverse hyperbolic sine |
atan | Inverse tangent, result in radians |
audioplayer | Create audio player object |
atan2 | Four-quadrant inverse tangent |
atand | Inverse tangent, result in degrees |
atanh | Inverse hyperbolic tangent |
audiorecorder | Create audio recorder object |
aufinfo | Return information about NeXT/SUN (.au ) sound file
|
auread | Read NeXT/SUN (.au ) sound file
|
auwrite | Write NeXT/SUN (.au ) sound file
|
avifile | Create new Audio/Video Interleaved (AVI) file |
aviinfo | Return information about Audio/Video Interleaved (AVI) file |
aviread | Read Audio/Video Interleaved (AVI) file |
axes | Create axes graphics object |
axes_props | Modifying Properties |
axis | Axis scaling and appearance |
b
barseriesproperties | Modifying Properties |
balance | Diagonal scaling to improve eigenvalue accuracy |
bar | Plot bar graph (vertical and horizontal) |
bar3 | Plot three-dimensional bar chart |
bar3h | Plot three-dimensional bar chart |
barh | Plot bar graph (vertical and horizontal) |
base2dec | Convert base N number string to decimal number |
beep | Produce beep sound |
besselh | Bessel function of the third kind (Hankel function) |
besseli | Modified Bessel function of the first kind |
besselj | Bessel function of the first kind |
besselk | Modified Bessel function of the second kind |
bessely | Bessel functions of the second kind |
beta | Beta function |
betainc | Incomplete beta function |
betaln | Logarithm of beta function |
bicg | Biconjugate gradients method |
bicgstab | Biconjugate gradients stabilized method |
bin2dec | Convert binary number string to decimal number |
binary | Set FTP transfer type to binary |
bitand | Return bitwise AND |
bitcmp | Return bitwise complement |
bitget | Get bit at specified position |
bitmax | Return maximum double-precision floating-point integer |
bitor | Return bitwise OR |
bitset | Set bit at specified position |
bitshift | Shift bits specified number of places |
bitxor | Return bitwise XOR |
blanks | Create string of blank characters |
blkdiag | Construct a block diagonal matrix from input arguments |
box | Display axes border |
break | Terminate execution of for or while loop
|
brighten | Brighten or darken colormap |
builtin | Execute built-in function from overloaded method |
bvp4c | Solve boundary value problems (BVPs) for ordinary differential equations |
bvpget | Extract properties from the options structure created with bvpset |
bvpinit | Form the initial guess for bvp4c
|
bvpset | Create or alter boundary value problem (BVP) options structure |
bvpval | Evaluate the numerical solution of a boundary value problem (BVP) using the output of bvp4c |
c
callsoapservice | Send SOAP message off to endpoint |
calendar | Display calendar for specified month |
calllib | Call function in external library |
cameratoolbar | Control camera toolbar programmatically |
camdolly | Move the camera position and target |
closeavifile | Close Audio/Video Interleaved (AVI) file |
camlight | Create or move a light object in camera coordinates |
camlookat | Position the camera to view an object or group of objects |
camorbit | Rotate the camera position around the camera target |
campan | Rotate the camera target around the camera position |
campos | Set or query the camera position |
camproj | Set or query the projection type |
camroll | Rotate the camera about the view axis |
camtarget | Set or query the location of the camera target |
camup | Set or query the camera up vector |
camva | Set or query the camera view angle |
camzoom | Zoom in and out on a scene |
cart2pol | Transform Cartesian coordinates to polar or cylindrical |
cart2sph | Transform Cartesian coordinates to spherical |
case | Execute block of code if condition is true
|
cast | Cast variable to different data type |
cat | Concatenate arrays along specified dimension |
catch | Specify how to respond to error in try statement
|
cd | Change working directory |
caxis | Color axis scaling |
cgs | Conjugate gradients squared method |
cdf2rdf | Convert complex diagonal form to real block diagonal form |
cdfepoch | Construct cdfepoch object for Common Data Format (CDF) export
|
cdfinfo | Return information about CDF file |
cdfread | Read data from CDF file |
cdftp | Change current directory on FTP server |
cdfwrite | Write data to CDF file |
ceil | Round toward infinity |
cell | Construct cell array |
cell2mat | Convert cell array of matrices to single matrix |
cell2struct | Convert cell array to structure array |
celldisp | Display cell array contents. |
cellfun | Apply function to each cell in cell array |
cellplot | Graphically display structure of cell arrays |
cellstr | Create cell array of strings from character array |
char | Convert to character array (string) |
checkin | Check files into source control system (UNIX only) |
checkout | Check files out of source control system (UNIX only) |
chol | Cholesky factorization |
cholinc | Sparse incomplete Cholesky and Cholesky-Infinity factorizations |
cholupdate | Rank 1 update to Cholesky factorization |
circshift | Shift array circularly |
cla | Clear current axes |
clabel | Contour plot elevation labels |
class | Create object or return class of object |
clc | Clear Command Window |
clear | Remove items from workspace, freeing up system memory |
clearserial | Remove a serial port object from the MATLAB workspace |
clf | Clear current figure window |
clipboard | Copy and paste strings to and from system clipboard |
clock | Return current time as date vector |
close | Delete specified figure |
closeftp | Close connection to FTP server |
colormapeditor | Start colormap editor |
closereq | Default figure close request function |
cmopts | Get name of source control system |
colamd | Column approximate minimum degree permutation |
colmmd | Sparse column minimum degree permutation |
colon | Create vectors, array subscripting, and for loop iterations
|
colorbar | Display colorbar showing the color scale |
colordef | Set default property values to display different color schemes |
colormap | Set and get the current colormap |
commandhistory | Open Command History window, or select it if already open |
colorspec | Color specification |
colperm | Sparse column permutation based on nonzero count |
comet | Two-dimensional comet plot |
comet3 | Three-dimensional comet plot |
contourgroupproperties | Modifying Properties |
commandwindow | Open Command Window, or select it if already open |
compan | Companion matrix |
compass | Plot arrows emanating from the origin |
complex | Construct complex data from real and imaginary components |
computer | Return information about computer on which MATLAB is running |
cond | Condition number with respect to inversion |
condeig | Condition number with respect to eigenvalues |
condest | 1-norm condition number estimate |
coneplot | Plot velocity vectors as cones in a 3-D vector field |
conj | Complex conjugate |
continue | Pass control to next iteration of for or while loop
|
contour | Contour graph of a matrix |
contour3 | Three-dimensional contour plot |
contourc | Low-level contour plot computation |
contourf | Filled two-dimensional contour plot |
createclassfromwsdl | Create MATLAB object based on WSDL file |
contourslice | Draw contours in volume slice planes |
contrast | Grayscale colormap for contrast enhancement |
conv | Convolution and polynomial multiplication |
conv2 | Two-dimensional convolution |
convhull | Convex hull |
convhulln | N-dimensional convex hull |
convn | N-dimensional convolution |
copyfile | Copy file or directory |
copyobj | Copy graphics objects and their descendants |
corrcoef | Correlation coefficients |
cos | Cosine of an argument in radians |
cosd | Cosine of an argument in degrees |
cosh | Hyperbolic cosine |
cot | Cotangent of an argument in radians |
cotd | Cotangent of an argument in degrees |
coth | Hyperbolic cotangent |
cov | Covariance matrix |
cplxpair | Sort complex numbers into complex conjugate pairs |
cputime | Return elapsed CPU time |
cscd | Cosecant of an argument in degrees |
createsoapmessage | Create SOAP message to send to server |
cross | Vector cross product |
csc | Cosecant of an argument in radians |
csch | Hyperbolic cosecant |
csvwrite | Write comma-separated value file |
csvread | Read comma-separated value file |
cumtrapz | Cumulative trapezoidal numerical integration |
cumprod | Cumulative product |
cumsum | Cumulative sum |
customverctrl | Allow custom source control system (UNIX only) |
curl | Computes the curl and angular velocity of a vector field |
cylinder | Generate cylinder |
d
datacursormode | Enable/disable interactive data cursor mode |
daspect | Set or query the axes data aspect ratio |
deleteproperty | Remove custom property from object |
datatipinfo | Produce short description of input variable |
date | Return current date string |
datenum | Convert date and time to serial date number |
datestr | Convert date and time to string format |
datetick | Label tick lines using dates |
datevec | Convert date and time to vector of components |
dbclear | Clear breakpoints |
dbcont | Resume execution |
dbdown | Change local workspace context when in debug mode |
dblquad | Numerically evaluate double integral |
dbmex | Enable MEX-file debugging |
dbquit | Quit debug mode |
dbstack | Display function call stack |
dbstatus | List all breakpoints |
dbstep | Execute one or more lines from current breakpoint |
dbstop | Set breakpoints |
dbtype | List M-file with line numbers |
dbup | Change local workspace context |
dde23 | Solve delay differential equations (DDEs) with constant delays |
ddeadv | Set up advisory link |
ddeexec | Send string for execution |
ddeget | Extract properties from options structure created with ddeset |
ddeinit | Initiate DDE conversation |
ddepoke | Send data to application |
ddereq | Request data from application |
ddeset | Create or alter delay differential equations (DDE) options structure |
ddeterm | Terminate DDE conversation |
ddeunadv | Release advisory link |
deal | Distribute inputs to outputs |
deblank | Strip trailing blanks from end of string |
debug | List M-file debugging functions |
dec2base | Convert decimal to base N number in string |
dec2bin | Convert decimal to binary number in string |
dec2hex | Convert decimal to hexadecimal number in string |
decic | Compute consistent initial conditions for ode15i
|
deconv | Deconvolution and polynomial division |
del2 | Discrete Laplacian |
delaunay | Delaunay triangulation |
delaunay3 | 3-dimensional Delaunay tessellation |
delaunayn | N-dimensional Delaunay tessellation |
delete | Delete files or graphics objects |
deletecom | Delete COM control or server |
deleteftp | Delete file on FTP server |
deleteserial | Remove a serial port object from memory |
deletetimer | Remove a timer object from memory |
demo | Access product demos via Help browser |
depdir | List dependent directories of M-file or P-file |
depfun | List dependencies of M-file or P-file |
det | Matrix determinant |
detrend | Remove linear trends. |
deval | Evaluate the solution of a differential equation |
diag | Diagonal matrices and diagonals of a matrix |
dialog | Create and display dialog box |
diary | Save session to file |
diff | Differences and approximate derivatives |
dir | Display directory listing |
dirftp | List contents of directory on FTP server |
disp | Display text or array |
display | Overloaded method to display text or array |
dispmemmapfile | Display information about memory map object |
dispserial | Display serial port object summary information |
disptimer | Display information about timer object |
divergence | Computes the divergence of a vector field |
dlmread | Read ASCII-delimited file of numeric data into matrix |
dlmwrite | Write matrix to ASCII-delimited file |
dmperm | Dulmage-Mendelsohn decomposition |
doc | Display online documentation in Help browser |
docopt | Web browser for UNIX platforms |
docsearch | Open Help browser Search pane and search for specified term |
dos | Execute DOS command and return result |
dot | Vector dot product |
double | Convert to double -precision |
dragrect | Drag rectangles with mouse |
drawnow | Complete pending drawing events |
dsearch | Search for nearest point |
dsearchn | N-dimensional nearest point search |
e
echo | Echo M-files during execution |
echodemo | Run M-file demo step-by-step in Command Window |
edit | Edit or create M-file |
eig | Find eigenvalues and eigenvectors |
eigs | Find largest eigenvalues and eigenvectors of a sparse matrix |
ellipj | Jacobi elliptic functions |
ellipke | Complete elliptic integrals of the first and second kind |
ellipsoid | Generate ellipsoid |
else | Conditionally execute statements |
elseif | Conditionally execute statements |
enableservice | Enable DDE or Automation server |
end | Terminate block of code, or indicate last index of array |
eomday | Return last day of month |
eps | Floating-point relative accuracy |
eq | Test for equality |
erf | Error functions |
erfc | Error functions |
erfcinv | Error functions |
erfcx | Error functions |
erfinv | Error functions |
error | Display error message |
errorbar | Plot error bars along a curve |
errordlg | Create and display an error dialog box |
errorbarseriesproperties | Modifying Properties |
etime | Return time elapsed between date vectors |
etree | Elimination tree |
etreeplot | Plot elimination tree |
eval | Execute string containing MATLAB expression |
evalc | Evaluate MATLAB expression with capture |
evalin | Execute MATLAB expression in specified workspace |
eventlisteners | Return list of events attached to listeners |
events | Return list of events control can trigger |
execute | Execute MATLAB command in server |
exifread | Read EXIF information from JPEG and TIFF image files |
exist | Check if variables or functions are defined |
exit | Terminate MATLAB (same as quit )
|
exp | Exponential |
expint | Exponential integral |
expm | Matrix exponential |
expm1 | Compute exp(x)-1 accurately for small values of x
|
eye | Identity matrix |
ezcontour | Easy to use contour plotter |
ezcontourf | Easy to use filled contour plotter |
ezmesh | Easy to use 3-D mesh plotter |
ezmeshc | Easy to use combination mesh/contour plotter |
ezplot | Easy to use function plotter |
ezplot3 | Easy to use 3-D parametric curve plotter |
ezpolar | Easy to use polar coordinate plotter |
ezsurf | Easy to use 3-D colored surface plotter |
ezsurfc | Easy to use combination surface/contour plotter |
f
factor | Prime factors |
factorial | Factorial function |
false | Return logical 0 (false) |
fclose | Close one or more open files |
fcloseserial | Disconnect a serial port object from the device |
feather | Plot velocity vectors |
feof | Test for end-of-file |
ferror | Query MATLAB about errors in file input or output |
feval | Evaluate function |
fevalcom | Evaluate MATLAB function in server |
fft | Discrete Fourier transform |
fft2 | Two-dimensional discrete Fourier transform |
fftn | Multidimensional discrete Fourier transform |
fftshift | Shift zero-frequency component of discrete Fourier transform to center of spectrum |
fftw | Interface to the FFTW library run-time algorithm for tuning fast Fourier transform (FFT) computations |
fgetl | Read line from file, discarding newline character |
fgetlserial | Read one line of text from the device and discard the terminator |
fgets | Read line from file, keeping newline character |
fgetsserial | Read one line of text from the device and include the terminator |
fieldnames | Return field names of structure, or public fields of object |
figure | Create a figure graphics object |
figure_props | Modifying Properties |
figurepalette | Show or hide figure palette |
fileattrib | Set or get attributes of file or directory |
filebrowser | Display Current Directory browser, a tool for viewing files in current directory |
fileformats | Readable file formats |
fileparts | Return filename parts |
filesep | Return directory separator for current platform |
fill | Filled two-dimensional polygons |
fill3 | Filled three-dimensional polygons |
filter | Filter data with an infinite impulse response (IIR) or finite impulse response (FIR) filter |
filter2 | Two-dimensional digital filtering |
find | Find indices and values of nonzero elements |
findall | Find all graphics objects |
findfigs | Find visible off-screen figures |
findobj | Locate graphics objects with specific properties |
findstr | Find string within another, longer string |
finish | MATLAB termination M-file |
fitsinfo | Return information about FITS file |
fitsread | Extract data from FITS file |
fix | Round towards zero |
flipdim | Flip array along a specified dimension |
fliplr | Flip matrices left-right |
flipud | Flip matrices up-down |
floor | Round towards minus infinity |
flops | Count floating-point operations |
flow | A simple function of three variables |
fminbnd | Minimize a function of one variable on a fixed interval |
fminsearch | Minimize a function of several variables |
fopen | Open file, or obtain information about open files |
fopenserial | Connect a serial port object to the device |
for | Execute block of code specified number of times |
format | Set display format for output |
fplot | Plot a function between specified limits |
fprintf | Write formatted data to file |
fprintfserial | Write text to the device |
frame2im | Convert movie frame to indexed image |
frameedit | Create and edit print frames for Simulink and Stateflow block diagrams |
fread | Read binary data from file |
freadserial | Read binary data from the device |
freqspace | Determine frequency spacing for frequency response |
frewind | Move file position indicator to beginning of open file |
fscanf | Read formatted data from file |
fscanfserial | Read data from the device, and format as text |
fseek | Set file position indicator |
ftell | Get file position indicator |
ftp | Connect to FTP server, creating FTP object |
full | Convert sparse matrix to full matrix |
fullfile | Build full filename from parts |
funm | Evaluate general matrix function |
fwrite | Write binary data to file |
fwriteserial | Write binary data to the device |
fzero | Find zero of a function of one variable |
g
getworkspacedata | Get data from server workspace |
gallery | Test matrices |
gamma | Gamma functions |
gammainc | Gamma functions |
gammaln | Gamma functions |
gca | Get current axes handle |
gcbf | Return handle of figure containing object whose callback is executing |
gcbo | Return handle of object whose callback is executing |
gcd | Greatest common divisor |
gcf | Get current figure handle |
gco | Return handle of current object |
ge | Test for greater than or equal to |
genpath | Generate path string |
genvarname | Construct valid variable name from string |
get | Get object properties |
getappdata | Get value of application-defined data |
getchararray | Get character array from server |
getcom | Get property value from interface, or display properties |
getenv | Get environment variable |
getfield | Get field of structure array |
getframe | Get movie frame |
getfullmatrix | Get matrix from server |
getmemmapfile | Return memmapfile object properties
|
getplottool | Utility function for creating and obtaining the figure components used for plot editing. |
getpref | Get preference |
getserial | Return serial port object properties |
gettimer | Display or get timer object properties |
getvariable | Returns data from variable in server workspace |
grabcode | Get MATLAB code from M-files published to HTML |
ginput | Graphical input from a mouse or cursor |
global | Declare global variables |
gmres | Generalized Minimum Residual method (with restarts) |
gplot | Plot set of nodes using an adjacency matrix |
gradient | Numerical gradient |
griddata | Data gridding |
gt | Test for greater than |
graymon | Set default figure properties for grayscale monitors |
grid | Grid lines for two- and three-dimensional plots |
griddata3 | Data gridding and hypersurface fitting for 3-D data |
griddatan | Data gridding and hypersurface fitting (dimension >= 2) |
gsvd | Generalized singular value decomposition |
gtext | Mouse placement of text in two-dimensional view |
guidata | Store or retrieve GUI data |
guide | Start the GUI Layout Editor |
guihandles | Create a structure of handles |
gunzip | Uncompress files in gzip format |
gzip | Compress files into gzip format |
h
hggroupproperties | Modifying Properties |
hadamard | Hadamard matrix |
hankel | Hankel matrix |
hdf | HDF interface |
hdf5 | HDF5 data type classes |
hdf5info | Return information about an HDF5 file |
hdf5read | Read data from an HDF5 file |
hdf5write | Write a Hierarchical Data Format (HDF) Version 5 file |
hdfinfo | Return information about an HDF or HDF-EOS file |
hdfread | Extract data from an HDF or HDF-EOS file |
hdftool | Browse and import data from HDF or HDF-EOS files |
help | Display help for MATLAB functions in Command Window |
helpbrowser | Display Help browser for access to full online documentation and demos |
helpdesk | Display Help browser |
helpdlg | Create and display help dialog box |
helpwin | Provide access to and display M-file help for all functions |
hess | Hessenberg form of a matrix |
hex2dec | Convert hexadecimal number string to decimal number |
hex2num | Convert hexadecimal number string to double-precision number |
hgexport | Export figure |
hggroup | Create hggroup object |
hgtransform | Create an hgtransform graphics object |
hgload | Load Handle Graphics object hierarchy from a file |
hgsave | Saves a Handle Graphics object hierarchy to a file |
hgtransformproperties | Modifying Properties |
Remove hidden lines from a mesh plot | |
hilb | Hilbert matrix |
hist | Histogram plot |
histc | Histogram count |
hold | Hold current graph in the figure |
home | Move cursor to upper left corner of Command Window |
horzcat | Concatenate arrays horizontally |
hostid | Return MATLAB server host identification number |
hsv2rgb | Convert HSV colormap to RGB colormap |
hypot | Square root of sum of squares |
i
ifft | Inverse discrete Fourier transform |
i | Imaginary unit |
if | Conditionally execute statements |
ifftshift | Inverse FFT shift |
ifft2 | Two-dimensional inverse discrete Fourier transform |
ifftn | Multidimensional inverse discrete Fourier transform |
im2frame | Convert indexed image into movie format |
image_props | Modifying Properties |
im2java | Convert image to Java image |
imag | Imaginary part of a complex number |
image | Display image object |
imformats | Manage file format registry |
imagesc | Scale data and display an image object |
imfinfo | Information about graphics file |
importdata | Load data from disk file |
import | Add package or class to current Java import list |
inferiorto | Establish inferior class relationship |
imread | Read image from graphics file |
imwrite | Write image to graphics file |
ind2rgb | Convert an indexed image to an RGB image |
ind2sub | Subscripts from linear index |
inf | Infinity |
inpolygon | Detect points inside a polygonal region |
info | Display information about contacting The MathWorks |
inline | Construct an inline object |
inmem | Return names of M-files, MEX-files, Java classes in memory |
inputdlg | Create and display input dialog box |
input | Request user input |
instrcallback | Display event information when an event occurs |
inputname | Return variable name of function input |
inspect | Display Property Inspector |
interpstreamspeed | Interpolate stream line vertices from flow speed |
instrfind | Return serial port objects from memory to the MATLAB workspace |
int16 | Convert to signed integer |
int2str | Convert integer to string |
int32 | Convert to signed integer |
int64 | Convert to signed integer |
int8 | Convert to signed integer |
interfaces | List custom interfaces to COM server |
interp1 | One-dimensional data interpolation (table lookup) |
interp2 | Two-dimensional data interpolation (table lookup) |
inv | Matrix inverse |
interp3 | Three-dimensional data interpolation (table lookup) |
interpft | One-dimensional interpolation using the FFT method |
interpn | Multidimensional data interpolation (table lookup) |
isvalidtimer | Determine if timer object is valid |
intersect | Find set intersection of two vectors |
intmax | Largest possible value of specified integer type |
intmin | Smallest possible value of specified integer type |
intwarning | Control state of integer warnings |
invhilb | Inverse of the Hilbert matrix |
invoke | Invoke method on object or interface, or display methods |
ipermute | Inverse permute the dimensions of a multidimensional array |
is | Detect state |
isa | Determine if input is object of given class |
isappdata | True if application-defined data exists |
iscell | Determine if input is cell array |
iscellstr | Determine if input is cell array of strings |
ischar | Determine if item is character array |
iscom | Determine if input is COM object |
isdir | Determine if input is a directory |
isempty | Determine if array is empty |
isequal | Test arrays for equality |
isevent | Determine if input is event |
isfield | Determine if input is MATLAB structure array field |
isequalwithequalnans | Test arrays for equality, treating NaN s as equal
|
isfinite | Detect finite elements of array |
isfloat | Determine if input is floating-point array |
isglobal | Determine if input is global variable |
ishandle | Returns true for graphics handles |
ishold | Returns current hold state |
isinf | Detect infinite elements of array |
isinteger | Determine if input is integer array |
isinterface | Determine if input is COM interface |
isjava | Determine if input is Java object |
iskeyword | Determine if input is MATLAB keyword |
isletter | Detect array elements that are letters of alphabet |
islogical | Determine if input is logical array |
ismember | Detect members of set |
ismethod | Determine if input is object method |
isnan | Detect NaN elements of array
|
isnumeric | Determine if input is numeric array |
isobject | Determine if input is MATLAB OOPs object |
isocaps | Compute isosurface end cap geometry |
isocolors | Calculates isosurface and patch colors |
isonormals | Compute normals of isosurface vertices |
isosurface | Extract isosurface data from volume data |
ispc | Determine if PC (Windows) version of MATLAB |
ispref | Test for existence of preference |
isprime | Detect prime elements of array |
isprop | Determine if input is object property |
isreal | Determine if all array elements are real numbers |
isscalar | Determine if input is scalar |
issorted | Determine if set elements are in sorted order |
isspace | Detect space characters in array |
issparse | Determine if input is sparse |
isstr | Determine if input is character array |
isstrprop | Determine if string is of specified category |
isstruct | Determine if input is MATLAB structure array |
isstudent | Determine if Student Version of MATLAB |
isunix | Determine if UNIX version of MATLAB |
isvalid | Determine if serial port objects are valid |
isvarname | Determine if input is valid variable name |
isvector | Determine if input is vector |
j
javaclasspath | Set and get dynamic Java class path |
j | Imaginary unit |
javaaddpath | Add Java classes to MATLAB using dynamic Java class path |
javaarray | Construct Java array |
javachk | Generate error message based on Java feature support |
javamethod | Invoke Java method |
javaobject | Construct Java object |
javarmpath | Remove entries from dynamic Java class path |
k
keyboard | Get input from keyboard |
kron | Kronecker tensor product |
l
lengthserial | Length of serial port object array |
lasterr | Return last error message |
lasterror | Return last error message and related information |
lastwarn | Return last warning message |
lcm | Least common multiple |
ldivide | Left or right array division |
le | Test for less than or equal to |
legend | Display a legend on graphs |
legendre | Associated Legendre functions |
length | Length of vector |
libfunctionsview | Create window displaying information on functions in external library |
libfunctions | Return information on functions in external library |
libisloaded | Determine if external library is loaded |
libpointer | Create pointer object for use with external libraries |
libstruct | Construct structure as defined in external library |
license | Return license number or perform licensing task |
light | Create a light object |
light_props | Modifying Properties |
lightangle | Create or position a light object in spherical coordinates |
lighting | Select the lighting algorithm |
lin2mu | Convert linear audio signal to mu-law |
line | Create line object |
line_props | Modifying Properties |
linespec | Line specification syntax |
listdlg | Create and display list selection dialog box |
lineseriesproperties | Modifying Properties |
linkaxes | Synchronize limits of specified 2-D axes |
linkprop | Keep same value for corresponding properties |
linsolve | Solve a linear system of equations |
linspace | Generate linearly spaced vectors |
load | Load workspace variables from disk |
loadcom | Initialize control object from file |
loadlibrary | Load external library into MATLAB |
loadobj | User-defined extension of load function for user objects
|
loadserial | Load serial port objects and variables into the MATLAB workspace |
log | Natural logarithm |
log10 | Common (base 10) logarithm |
log1p | Compute log(1+x) accurately for small values of x
|
log2 | Base 2 logarithm and dissect floating-point numbers into exponent and mantissa |
logical | Convert numeric values to logical |
logicaloperatorsshortcircuit | Logical operations, with short-circuiting capability |
logicaloperatorselementwise | Elementwise logical operations on arrays |
loglog | Log-log scale plot |
logm | Matrix logarithm |
logspace | Generate logarithmically spaced vectors |
lookfor | Search for keyword in all help entries |
lower | Convert string to lowercase |
ls | Display directory contents on UNIX system |
lscov | Least squares solution in the presence of known covariance |
lsqnonneg | Linear least squares with nonnegativity constraints |
lsqr | LSQR method |
lt | Test for less than |
lu | LU matrix factorization |
luinc | Incomplete LU matrix factorizations |
m
matlabwindows | Start MATLAB (Windows systems) |
magic | Magic square |
makehgtform | Create 4-by-4 transform matrix |
mat2cell | Divide matrix into cell array of matrices |
mat2str | Convert matrix to string |
material | Controls the reflectance properties of surfaces and patches |
max | Maximum elements of an array |
mex | Compile MEX-function from C or Fortran source code |
min | Minimum elements of an array |
matlabcolon | Run specified function via hyperlink |
matlabrc | MATLAB startup M-file for single-user systems or system administrators |
matlabroot | Return root directory of MATLAB installation |
matlabunix | Start MATLAB (UNIX systems) |
mode | Find most frequent values in sample |
mod | Modulus after division |
maximizecommandwindow | Display server window on Windows desktop |
mean | Average or mean value of arrays |
median | Median value of arrays |
memmapfile | Construct memory map object |
memory | Help for memory limitations |
Generate menu of choices for user input | |
mesh | Mesh plots |
meshc | Mesh plots |
meshgrid | Generate X and Y matrices for three-dimensional plots
|
meshz | Mesh plots |
methods | Display information on class methods |
methodsview | Display information on class methods in separate window |
mexext | Return MEX-filename extension |
mfilename | Return name of currently running M-file |
mget | Download file from FTP server |
minimizecommandwindow | Minimize size of server window |
minres | Minimum residual method |
mislocked | Determine if M-file or MEX-file cannot be cleared from memory |
mkdir | Make new directory |
mkdirftp | Create new directory on FTP server |
mkpp | Make a piecewise polynomial |
mldivide | right matrix division |
mlint | Check M-files for possible problems, and report results |
mlintrpt | Run mlint for file or directory, reporting results in Web browser |
mlock | Prevent clearing M-file or MEX-file from memory |
mmfileinfo | Return information about multimedia file |
movefile | Move file or directory |
more | Control paged output for Command Window |
move | Move or resize control in parent window |
movie2avi | Create Audio/Video Interleaved (AVI) movie from MATLAB movie |
movegui | Move GUI figure to specified location on screen |
movie | Play recorded movie frames |
mrdivide | right matrix division |
mput | Upload file or directory to FTP server |
multibandread | Read band interleaved data from binary file |
msgbox | Create and display message box |
mtimes | Matrix multiplication |
mu2lin | Convert mu-law audio signal to linear |
multibandwrite | Write multiband data to file |
munlock | Allow clearing M-file or MEX-file from memory |
n
namelengthmax | Return maximum identifier length |
nan | Not-a-Number |
nargchk | Validate number of input arguments |
nargin | Return number of function arguments |
nargout | Return number of function arguments |
nargoutchk | Validate number of output arguments |
native2unicode | Convert numeric bytes to Unicode characters |
nchoosek | Binomial coefficient or all combinations |
ndgrid | Generate arrays for multidimensional functions and interpolation |
ndims | Number of array dimensions |
ne | Test for inequality |
newplot | Determine where to draw graphics objects |
nextpow2 | Next power of two |
nnz | Number of nonzero matrix elements |
noanimate | Change EraseMode of all objects to normal
|
nonzeros | Nonzero matrix elements |
norm | Vector and matrix norms |
normest | 2-norm estimate |
not | Find logical NOT of array or scalar input |
notebook | Open M-book in Microsoft Word (Windows only) |
now | Return current date and time |
nthroot | Real n th root of real numbers
|
null | Null space of a matrix |
num2cell | Convert numeric array to cell array |
num2hex | Convert singles and doubles to IEEE hexadecimal strings. |
num2str | Convert number to string |
numel | Number of elements in array or subscripted array expression |
nzmax | Amount of storage allocated for nonzero matrix elements |
o
ode113 | Solve initial value problems for ordinary differential equations (ODEs) |
ode15i | Solve fully implicit differential equations, variable order method |
ode15s | Solve initial value problems for ordinary differential equations (ODEs) |
ode23 | Solve initial value problems for ordinary differential equations (ODEs) |
ode23s | Solve initial value problems for ordinary differential equations (ODEs) |
ode23t | Solve initial value problems for ordinary differential equations (ODEs) |
ode23tb | Solve initial value problems for ordinary differential equations (ODEs) |
ode45 | Solve initial value problems for ordinary differential equations (ODEs) |
odefile | Define a differential equation problem for ordinary differential equation (ODE) solvers |
odeget | Extract properties from options structure created with odeset |
odeset | Create or alter options structure for input to ordinary differential equation (ODE) solvers |
odextend | Extend the solution of an initial value problem for an ordinary differential equation (ODE) |
ones | Create an array of all ones |
open | Open files based on extension |
openfig | Open new copy or raise existing copy of saved figure |
opengl | Control OpenGL rendering |
openvar | Open workspace variable in Array Editor or other tool for graphical editing |
optimget | Get optimization options structure parameter values |
optimset | Create or edit an optimization options structure
|
or | Find logical OR of array or scalar inputs |
ordeig | Eigenvalues of quasitriangular matrices |
orderfields | Order fields of structure array |
ordqz | Reorder eigenvalues in QZ factorization |
ordschur | Reorder eigenvalues in Schur factorization |
orient | Set paper orientation for printed output |
orth | Range space of a matrix |
otherwise | Default part of switch statement |
p
parsesoapresponse | Convert response string from SOAP server into MATLAB data types |
pack | Consolidate workspace memory |
pagesetupdlg | Display page setup dialog box |
pan | Pan the view of a graph interactively |
pareto | Pareto chart |
printpreview | Preview figure to be printed |
partialpath | Partial pathname description |
pascal | Pascal matrix |
patch | Create patch graphics object |
patch_props | Modifying Properties |
path | View or change MATLAB directory search path |
path2rc | Save current MATLAB search path to pathdef.m file
|
pathdef | List of directories in MATLAB search path |
pathsep | Return path separator for current platform |
pathtool | Open Set Path dialog box to view and change MATLAB path |
pause | Halt execution temporarily |
pbaspect | Set or query the plot box aspect ratio |
pcg | Preconditioned conjugate gradients method |
pchip | Piecewise Cubic Hermite Interpolating Polynomial (PCHIP) |
pcode | Create preparsed pseudocode file (P-file) |
pcolor | Pseudocolor plot |
pdepe | Solve initial-boundary value problems for systems of parabolic and elliptic partial differential equations (PDEs) in one space variable and time |
pdeval | Evaluate the numerical solution of a PDE using the output of pdepe |
peaks | A sample function of two variables. |
perl | Call Perl script using appropriate operating system executable |
perms | All possible permutations |
permute | Rearrange the dimensions of a multidimensional array |
persistent | Define persistent variable |
pi | Ratio of a circle's circumference to its diameter, http://itp.tugraz.at/matlab/techdoc/ref/math_p47.gif |
pie | Pie chart |
pie3 | Three-dimensional pie chart |
pinv | Moore-Penrose pseudoinverse of a matrix |
planerot | Givens plane rotation |
playshow | Run M-file demo (deprecated; use echodemo instead) |
plot | Linear 2-D plot |
plot3 | 3-D line plot |
plotbrowser | Show or hide figure plotbrowser |
plotedit | Start plot edit mode to allow editing and annotation of plots |
plotmatrix | Draw scatter plots |
plottools | Show or hide the plot tools |
plotyy | Create graphs with y-axes on both left and right side |
pol2cart | Transform polar or cylindrical coordinates to Cartesian |
polar | Plot polar coordinates |
poly | Polynomial with specified roots |
polyarea | Area of polygon |
polyder | Polynomial derivative |
polyeig | Polynomial eigenvalue problem |
polyfit | Polynomial curve fitting |
polyint | Integrate polynomial analytically |
polyval | Polynomial evaluation |
polyvalm | Matrix polynomial evaluation |
pow2 | Base 2 power and scale floating-point numbers |
power | Array power |
ppval | Evaluate piecewise polynomial |
prefdir | Return directory containing preferences, history, and layout files |
preferences | Display Preferences dialog box for MATLAB and related products |
primes | Generate list of prime numbers |
Create hardcopy output | |
printdlg | Display print dialog box |
printopt | Create hardcopy output |
publish | Run M-file script containing cells, and save results to file of specified type |
prod | Product of array elements |
profile | Profile execution time for function |
profsave | Save profile report in HTML format |
propedit | Starts the Property Editor |
propeditcom | Display built-in property page for control |
propertyeditor | Show or hide property editor |
psi | Psi (polygamma) function |
putworkspacedata | Store data in server workspace |
putchararray | Store character array in server |
putfullmatrix | Store matrix in server |
pwd | Identify current directory |
q
qrdelete | Delete column or row from QR factorization |
qmr | Quasi-minimal residual method |
qr | Orthogonal-triangular decomposition |
qrinsert | Insert column or row into QR factorization |
qrupdate | |
quad | Numerically evaluate integral, adaptive Simpson quadrature |
quad8 | Numerically evaluate integral, adaptive Simpson quadrature |
quadl | Numerically evaluate integral, adaptive Lobatto quadrature |
quadv | Vectorized quadrature |
questdlg | Create and display question dialog box |
quit | Terminate MATLAB |
quitcom | Terminate MATLAB server |
quiver | Quiver or velocity plot |
quiver3 | Three-dimensional velocity plot |
qz | QZ factorization for generalized eigenvalues |
quivergroupproperties | Modifying Properties |
r
rectangle_props | Modifying Properties |
rand | Uniformly distributed pseudorandom numbers |
randn | Normally distributed random numbers and arrays |
randperm | Random permutation |
rank | Rank of a matrix |
rat | Rational fraction approximation |
rats | Rational fraction approximation |
rbbox | Create rubberband box for area selection |
rcond | Matrix reciprocal condition number estimate |
rdivide | Left or right array division |
readasync | Read data asynchronously from the device |
real | Real part of complex number |
reallog | Natural logarithm for nonnegative real arrays |
realmax | Largest positive floating-point number |
realmin | Smallest positive floating-point number |
realpow | Array power for real-only output |
realsqrt | Square root for nonnegative real arrays |
record | Record data and event information to a file |
rectangle | Create a 2-D rectangle object |
reducepatch | Reduce the number of patch faces |
rectint | Rectangle intersection area. |
recycle | Set option to move deleted files to recycle folder |
reducevolume | Reduce the number of elements in a volume data set |
relationaloperators | Relational operations |
refresh | Redraw current figure |
refreshdata | Refresh data in graph when data source is specified |
regexp | Match regular expression |
regexpi | Match regular expression |
regexprep | Replace string using regular expression |
registerevent | Register event handler with control's event |
rehash | Refresh function and file system path caches |
rmappdata | Remove application-defined data |
release | Release interface |
rem | Remainder after division |
rename | Rename file on FTP server |
repmat | Replicate and tile an array |
reset | Reset graphics object properties to their defaults |
reshape | Reshape array |
residue | Convert between partial fraction expansion and polynomial coefficients |
rethrow | Reissue error |
return | Return to invoking function |
restoredefaultpath | Restore default MATLAB search path |
rgb2hsv | Convert RGB colormap to HSV colormap |
rgbplot | Plot colormap |
ribbon | Ribbon plot |
rmdirftp | Remove directory on FTP server |
rmdir | Remove directory |
rootobject | Root object properties |
rmfield | Remove fields from structure |
rmpath | Remove directories from MATLAB search path |
rmpref | Remove preference |
run | Run script that is not on current path |
rootobject_props | Modifying Properties |
roots | Polynomial roots |
rose | Angle histogram |
rosser | Classic symmetric eigenvalue test problem |
rot90 | Rotate matrix 90° |
rotate | Rotate object about a specified direction |
rotate3d | Rotate 3-D view using mouse |
round | Round to nearest integer |
rref | Reduced row echelon form |
rsf2csf | Convert real Schur form to complex Schur form |
s
save | Save workspace variables on disk |
savepath | Save current MATLAB search path to pathdef.m file
|
saveas | Save figure or model using specified format |
savecom | Serialize control object to file |
saveobj | User-defined extension of save function for user objects
|
selectmoveresize | Select, move, resize, or copy axes and uicontrol graphics objects |
saveserial | Save serial port objects and variables to a MAT-file |
scatter | Plot a scatter (bubble) graph |
scatter3 | 3-D scatter plot |
schur | Schur decomposition |
script | Script M-file description |
scattergroupproperties | Modifying Properties |
sec | Secant of an argument in radians |
secd | Secant of an argument in degrees |
sech | Hyperbolic secant |
showplottool | Show or hide one of the figure plot tools |
semilogx | Semilogarithmic plots |
semilogy | Semilogarithmic plots |
send | Return list of events control can trigger |
sendmail | Send e-mail message to list of addresses |
serial | Create a serial port object |
serialbreak | Send a break to the device connected to the serial port |
set | Set object properties |
setappdata | Specify application-defined data |
setcom | Set object or interface property to specified value |
setdiff | Find set difference of two vectors |
setfield | Set value of structure array field |
setpref | Set preference |
setserial | Configure or display serial port object properties |
setstr | Set string flag |
settimer | Configure or display timer object properties |
setxor | Find set exclusive OR of two vectors |
shading | Set color shading properties |
shiftdim | Shift dimensions |
specialcharacters | Special characters |
shrinkfaces | Reduce the size of patch faces |
sign | Signum function |
sin | Sine of an argument in radians |
sind | Sine of an argument in degrees |
single | Convert to single-precision |
sinh | Hyperbolic sine of an argument in radians |
size | Array dimensions |
sizeserial | Size of serial port object array |
slice | Volumetric slice plot |
smooth3 | Smooth 3-D data |
sort | Sort array elements in ascending or descending order |
sortrows | Sort rows in ascending order |
sound | Convert vector into sound |
soundsc | Scale data and play as sound |
spalloc | Allocate space for sparse matrix |
sparse | Create sparse matrix |
spaugment | Form least squares augmented system |
spconvert | Import matrix from sparse matrix external format |
spdiags | Extract and create sparse band and diagonal matrices |
sph2cart | Transform spherical coordinates to Cartesian |
speye | Sparse identity matrix |
spfun | Apply function to nonzero sparse matrix elements |
sprandsym | returns a symmetric random matrix whose lower triangle and diagonal have the same structure as S . Its elements are normally distributed, with mean 0 and variance 1 .
|
sphere | Generate sphere |
spinmap | Spin colormap |
spline | Cubic spline data interpolation |
spones | Replace nonzero sparse matrix elements with ones |
spparms | Set parameters for sparse matrix routines |
sprand | Sparse uniformly distributed random matrix |
sprandn | Sparse normally distributed random matrix |
sprank | Structural rank |
stopasync | Stop asynchronous read and write operations |
sprintf | Write formatted data to string |
spy | Visualize sparsity pattern |
sqrt | Square root |
sqrtm | Matrix square root |
squeeze | Remove singleton dimensions |
ss2tf | Convert state-space filter parameters to transfer function form |
sscanf | Read string under format control |
stairs | Stairstep graph |
start | Start timer(s) running |
startat | Start timer(s) running at the specified time |
stairseriesproperties | Modifying Properties |
startup | MATLAB startup M-file for user-defined options |
std | Standard deviation |
stem | Plot discrete sequence data |
stem3 | Plot three-dimensional discrete sequence data |
stop | Stop timer(s) |
str2double | Convert string to double-precision value |
stemseriesproperties | Modifying Properties |
streamparticles | Display stream particles |
str2func | Construct function handle from function name string |
str2mat | Form blank-padded character matrix from strings |
str2num | Convert string to number |
strcat | Concatenate strings horizontally |
strcmp | Compare strings |
strcmpi | Compare strings, ignoring case |
stream2 | Compute 2-D streamline data |
stream3 | Compute 3-D streamline data |
streamline | Draw streamlines from 2-D or 3-D vector data |
surfaceplotproperties | Modifying Properties |
streamribbon | Create a 3-D stream ribbon plot |
streamslice | Draws streamlines in slice planes |
streamtube | Creates a 3-D stream tube plot |
strfind | Find one string within another |
strings | MATLAB string handling |
strjust | Justify character array |
strmatch | Find possible matches for string |
strncmp | Compare first n characters of strings
|
strncmpi | Compare first n characters of strings, ignoring case
|
strread | Read formatted data from string |
strrep | Find and replace substring |
strtok | Return selected parts of string |
strtrim | Remove leading and trailing white-space from string |
struct | Create structure array |
struct2cell | Convert structure to cell array |
structfun | Apply function to each field of scalar structure |
strvcat | Concatenate strings vertically |
sub2ind | Single index from subscripts |
subplot | Create axes object in tiled positions |
subsasgn | Overloaded method for A(I)=B , A{I}=B , and A.field=B
|
subsindex | Overloaded method for X(A)
|
subspace | Angle between two subspaces |
subsref | Overloaded method for A(I) , A{I} and A.field
|
substruct | Create structure argument for subsasgn or subsref
|
subvolume | Extract subset of volume data set |
sum | Sum of array elements |
superiorto | Establish superior class relationship |
support | Open MathWorks Technical Support Web page |
surf | 3-D shaded surface plot |
surf2patch | Convert surface data to patch data |
surface | Create surface object |
surface_props | Modifying Properties |
surfnorm | Compute and display 3-D surface normals |
surfc | 3-D shaded surface plot |
surfl | Surface plot with colormap-based lighting |
svds | A few singular values |
svd | Singular value decomposition |
swapbytes | Swap byte ordering |
switch | Switch among several cases, based on expression |
symamd | Symmetric approximate minimum degree permutation |
symbfact | Symbolic factorization analysis |
symmlq | Symmetric LQ method |
symmmd | Sparse symmetric minimum degree ordering |
symrcm | Sparse reverse Cuthill-McKee ordering |
symvar | Determine the symbolic variables in an expression |
syntax | Two ways to call MATLAB functions |
system | Execute operating system command and return result |
t
timerfindall | Find timer objects, including invisible objects |
tan | Tangent of an argument in radians |
tand | Tangent of an argument in degrees |
tanh | Hyperbolic tangent |
tar | Compress files into TAR-file |
tempdir | Return name of system's temporary directory |
tempname | Unique name for temporary file |
tetramesh | Tetrahedron mesh plot |
texlabel | Produce TeX format from character string |
text | Create text object in current axes |
text_props | Modifying Properties |
textread | Read data from text file, write to multiple outputs |
textscan | Read data from text file, convert, and write to cell array |
textwrap | Return wrapped string matrix for given uicontrol |
tic | Measure performance using stopwatch timer |
timer | Construct timer object |
timerfind | Find timer objects |
todatenum | Convert CDF epoch object to MATLAB datenum |
title | Add title to current axes |
toc | Measure performance using stopwatch timer |
toeplitz | Toeplitz matrix |
trace | Sum of diagonal elements |
trapz | Trapezoidal numerical integration |
treelayout | Lay out tree or forest |
treeplot | Plot picture of tree |
tril | Lower triangular part of a matrix |
trimesh | Triangular mesh plot |
triplequad | Numerically evaluate triple integral |
triplot | 2-D triangular plot |
trisurf | Triangular surface plot |
triu | Upper triangular part of a matrix |
true | Return logical 1 (true) |
try | Attempt to execute block of code, and catch errors |
tsearch | Search for enclosing Delaunay triangle |
tsearchn | N-dimensional closest simplex search |
type | Display contents of file |
typecast | Convert data types without changing underlying data |
u
Create container object to exclusively manage radio buttons and toggle buttons | |
Modifying Properties | |
Create context menu | |
Modifying Properties | |
uicontrol | Create user interface control object |
uicontrol_props | Modifying Properties |
uigetdir | Display standard dialog box for selecting a directory |
uigetfile | Display standard dialog box for retrieving files |
uigetpref | Display dialog box for retrieving preferences |
uiimport | Open Import Wizard interface to import data |
Create menus on figure windows | |
Modifying Properties | |
uint16 | Convert to unsigned integer |
uint32 | Convert to unsigned integer |
uint64 | Convert to unsigned integer |
uint8 | Convert to unsigned integer |
uiopen | Display file selection dialog box with appropriate file filters |
uipanel | Create panel container object |
uipanelproperties | Modifying Properties |
uipushtool | Create push button on a toolbar |
uipushtool_props | Modifying Properties |
uiputfile | Display standard dialog box for saving files |
uiresume | Control program execution |
uisave | Display standard dialog box for saving workspace variables |
uisetcolor | Display standard dialog box for setting an object's ColorSpec |
uisetfont | Display standard dialog box for setting an object's font characteristics |
uisetpref | Manage preferences used in uigetpref
|
uistack | Restack objects |
uitoggletool | Create toggle button on a toolbar |
uitoggletool_props | Modifying Properties |
uitoolbar | Create toolbar on a figure |
uitoolbarproperties | Modifying Properties |
uiwait | Control program execution |
undocheckout | Undo previous checkout from source control system (UNIX only) |
unicode2native | Convert Unicode characters to numeric bytes |
union | Find set union of two vectors |
unique | Find unique elements of vector |
unix | Execute UNIX command and return result |
unloadlibrary | Unload external library from memory |
unmkpp | Piecewise polynomial details |
unregisterallevents | Unregister all events for control |
unregisterevent | Unregister event handler with control's event |
untar | Extract contents of TAR-file |
unwrap | Correct phase angles to produce smoother phase plots |
unzip | Extract contents of ZIP-file |
upper | Convert string to uppercase |
urlread | Read content at URL |
urlwrite | Save contents of URL to file |
usejava | Determine if Java feature is supported in MATLAB |
v
varargin | Return variable number of arguments |
var | Variance |
vander | Vandermonde matrix |
volumebounds | Return coordinate and color limits for volume data |
varargout | Return variable number of arguments |
vectorize | Vectorize expression |
ver | Display version information for MathWorks products |
verctrl | Source control actions (Windows only) |
version | Display version number for MATLAB |
vertcat | Concatenate arrays vertically |
view | Viewpoint specification |
viewmtx | View transformation matrices |
voronoi | Voronoi diagram |
voronoin | N-dimensional Voronoi diagram |
w
Wait for key or mouse button press | |
wait | Wait until a timer stops running |
waitbar | Display waitbar |
waitfor | Wait for condition before resuming execution |
waterfall | Waterfall plot |
warndlg | Display warning dialog box |
warning | Display warning message |
wavfinfo | Return information about Microsoft WAVE (.wav ) sound file
|
wavplay | Play recorded sound on PC-based audio output device |
wavread | Read Microsoft WAVE (.wav ) sound file
|
wavrecord | Record sound using PC-based audio input device. |
wavwrite | Write Microsoft WAVE (.wav ) sound file
|
web | Open Web site or file in Web browser or Help browser |
weekday | Return day of week |
what | List MATLAB files in current directory |
whatsnew | Display Release Notes for MathWorks products |
which | Locate functions and files |
while | Repeatedly execute statements while condition is true |
whitebg | Change axes background color |
who | List variables in workspace |
whos | List variables in workspace |
wilkinson | Wilkinson's eigenvalue test matrix |
winopen | Open file in appropriate application (Windows only) |
winqueryreg | Get item from Microsoft Windows registry |
wk1finfo | Determine if file contains Lotus WK1 worksheet |
wk1read | Read Lotus123 spreadsheet file (.wk1 )
|
wk1write | Write matrix to Lotus123 WK1 spreadsheet file |
workspace | Display Workspace browser, a tool for managing the workspace |
x
xlabel | Label the x-, y-, and z-axis |
xlim | Set or query axis limits |
xlsfinfo | Determine if file contains Microsoft Excel (.xls ) spreadsheet
|
xlsread | Read Microsoft Excel spreadsheet file (.xls )
|
xlswrite | Write Microsoft Excel spreadsheet file (.xls )
|
xmlread | Parse XML document and return Document Object Model node |
xmlwrite | Serialize XML Document Object Model node |
xor | Logical exclusive-OR |
xslt | Transform XML document using XSLT engine |
y
ylabel | Label the x-, y-, and z-axis |
ylim | Set or query axis limits |
z
zeros | Create an array of all zeros |
zip | Compress files into ZIP-file archive |
zlabel | Label the x-, y-, and z-axis |
zlim | Set or query axis limits |
zoom | Zoom in and out on a 2-D plot |