You are on page 1of 12

Remove items from the workspace Build full filename from parts

MATLAB Quick Reference clear fullfile


Author: Jialong He disp Display text or array info Display contact information or toolbox Readme files
Jialong_he@bigfoot.com length Length of vector inmem Functions in memory
http://www.bigfoot.com/~jialong_he
load Retrieve variables from disk ls List directory on UNIX
General Purpose Commands memory Help for memory limitations matlabroot Get root directory of MATLAB installation

Managing Commands and Functions mlock Prevent M-file clearing mkdir Make new directory
munlock Allow M-file clearing open Open files based on extension
addpath Add directories to MATLAB’s search path
Open workspace variable in Array Editor, for graphical pwd Display current directory
doc Display HTML documentation in Help browser openvar
editing
tempdir Return the name of the system’s temporary directory
docopt Display location of help file directory for UNIX platforms
pack Consolidate workspace memory
tempname Unique name for temporary file
genpath Generate a path string Save workspace variables on disk
save
undocheckout Undo previous checkout from source control system
Display M-file help for MATLAB functions in the Save figure or model using specified format
help saveas Execute a UNIX command and return the result
Command Window unix
size Array dimensions
Display Help browser for access to all MathWorks online ! Execute operating system command
helpbrowser List the variables in the workspace
help who, whos
helpdesk Display the Help browser Display the Workspace Browser, a GUI for managing the
workspace workspace
Display M-file help and provide access to M-file help for Starting and Quitting MATLAB
helpwin all functions
finish MATLAB termination M-file
lasterr Last error message Terminate MATLAB
Controlling the Command Window exit
lastwarn Last warning message Start MATLAB (UNIX systems only)
Clear Command Window matlab
clc
license license MATLAB startup M-file
matlabrc
echo Echo M-files during execution
lookfor Search for specified keyword in all help entries Terminate MATLAB
Control the display format for output quit
format
partialpath Partial pathname MATLAB startup M-file
Move cursor to upper left corner of Command Window startup
home
path Control MATLAB’s directory search path
more Control paged output for the Command Window
Open the GUI for viewing and modifying MATLAB’s
pathtool
path Operators and Special Characters
+ Plus
Start the M-file profiler, a utility for debugging and
profile optimizing code Working with Operating Environment - Minus
profreport Generate a profile report beep Produce a beep sound * Matrix multiplication
rehash Refresh function and file system caches cd Change working directory .* Array multiplication
rmpath Remove directories from MATLAB’s search path checkin Check file into source control system ^ Matrix power
support Open MathWorks Technical Support Web Page checkout Check file out of source control system .^ Array power
type List file Get name of source control system, and PVCS project kron Kronecker tensor product
cmopts filename
Display version information for MATLAB, Simulink, and \ Backslash or left division
ver toolboxes copyfile Copy file
/ Slash or right division
version Get MATLAB version number customverctrl Allow custom source control system Array division, right and left
./ and .\
web Point Help browser or Web browser at file or Web site delete Delete files or graphics objects
: Colon
what List MATLAB-specific files in current directory diary Save session to a disk file
() Parentheses
whatsnew Display README files for MATLAB and toolboxes dir Display a directory listing
[] Brackets
which Locate functions and files dos Execute a DOS command and return the result
{} Curly braces
edit Edit an M-file
. Decimal point
fileparts Get filename parts
... Continuation
Managing Variables and the Workspace filebrowser Display Current Directory browser, for viewing files
, Comma cos, cosh Cosine and hyperbolic cosine case Case switch
; Semicolon cot, coth Cotangent and hyperbolic cotangent catch Begin catch block
% Comment csc, csch Cosecant and hyperbolic cosecant continue Pass control to the next iteration of for or while loop
! Exclamation point exp Exponential else Conditionally execute statements
‘ Transpose and quote fix Round towards zero elseif Conditionally execute statements
.’ Nonconjugated transpose floor Round towards minus infinity Terminate for, while, switch, try, and if statements or
end indicate last index
= Assignment gcd Greatest common divisor
error Display error messages
== Equality imag Imaginary part of a complex number
for Repeat statements a specific number of times
<> Relational operators lcm Least common multiple
if Conditionally execute statements
& Logical and log Natural logarithm
otherwise Default part of switch statement
| Logical or Base 2 logarithm and dissect floating-point numbers into
log2 exponent and mantissa Return to the invoking function
Logical not return
~
log10 Common (base 10) logarithm switch Switch among several cases based on expression
xor Logical exclusive or
mod Modulus (signed remainder after division) try Begin try block
nchoosek Binomial coefficient or all combinations warning Display warning message
Logical Functions
real Real part of complex number while Repeat statements an indefinite number of times
all Test to determine if all elements are nonzero
rem Remainder after division
any Test for any nonzeros
round Round to nearest integer
exist Check if a variable or file exists Interactive Input
sec, sech Secant and hyperbolic secant
find Find indices and values of nonzero elements
input Request user input
sign Signum function
is* Detect state
keyboard Invoke the keyboard in an M-file
sin, sinh Sine and hyperbolic sine
isa Detect an object of a given class
menu Generate a menu of choices for user input
sqrt Square root
iskeyword Test if string is a MATLAB keyword
pause Halt execution temporarily
tan, tanh Tangent and hyperbolic tangent
isvarname Test if string is a valid variable name
logical Convert numeric values to logical
mislocked True if M-file cannot be cleared Language Constructs and Debugging Object-Oriented Programming
MATLAB as a Programming Language class Create object or return class of object
Elementary Math Functions builtin Execute builtin function from overloaded method double Convert to double precision
abs Absolute value and complex magnitude eval Interpret strings containing MATLAB expressions inferiorto Inferior class relationship
acos, acosh Inverse cosine and inverse hyperbolic cosine evalc Evaluate MATLAB expression with capture inline Construct an inline object
acot, acoth Inverse cotangent and inverse hyperbolic cotangent evalin Evaluate expression in workspace int8, int16, int32 Convert to signed integer
acsc, acsch Inverse cosecant and inverse hyperbolic cosecant feval Function evaluation isa Detect an object of a given class
angle Phase angle function Function M-files loadobj Extends the load function for user objects
asec, asech Inverse secant and inverse hyperbolic secant global Define global variables saveobj Save filter for objects
asin, asinh Inverse sine and inverse hyperbolic sine nargchk Check number of input arguments single Convert to single precision
atan, atanh Inverse tangent and inverse hyperbolic tangent persistent Define persistent variable superiorto Superior class relationship
atan2 Four-quadrant inverse tangent script Script M-files uint8, uint16, uint32 Convert to unsigned integer
ceil Round toward infinity
Construct complex data from real and imaginary
complex components Control Flow Debugging
conj Complex conjugate break Terminate execution of for loop or while loop dbclear Clear breakpoints
dbcont Resume execution strncmp Compare the first n characters of strings : (colon) Regularly spaced vector
dbdown Change local workspace context strncmpi Compare the first n characters of strings, ignoring case
dbmex Enable MEX-file debugging strrep String search and replace
Quit debug mode First token in string
Special Variables and Constants
dbquit strtok
ans The most recent answer
dbstack Display function call stack strvcat Vertical concatenation of strings
computer Identify the computer on which MATLAB is running
dbstatus List all breakpoints symvar Determine symbolic variables in an expression
eps Floating-point relative accuracy
dbstep Execute one or more lines from a breakpoint texlabel Produce the TeX format from a character string
i Imaginary unit
dbstop Set breakpoints in an M-file function upper Convert string to upper case
Inf Infinity
dbtype List M-file with line numbers
inputname Input argument name
dbup Change local workspace context
String to Number Conversion j Imaginary unit
char Create character array (string) NaN Not-a-Number
Function Handles int2str Integer to string conversion nargin, Number of function arguments
Convert a matrix into a string nargout
function_ha MATLAB data type that is a handle to a function mat2str
ndle nargoutchk Validate number of output arguments
num2str Number to string conversion
functions Return information about a function handle pi Ratio of a circle’s circumference to its diameter,
sprintf Write formatted data to a string
func2str Constructs a function name string from a function handle realmax Largest positive floating-point number
sscanf Read string under format control
str2func Constructs a function handle from a function name string realmin Smallest positive floating-point number
str2double Convert string to double-precision value
String to matrix conversion varargin, Pass or return variable numbers of arguments
str2mat
varargout
Character String Functions str2num String to number conversion
General
abs Absolute value and complex magnitude Time and Dates
Radix Conversion
eval Interpret strings containing MATLAB expressions calendar Calendar
bin2dec Binary to decimal number conversion
real Real part of complex number clock Current time as a date vector
dec2bin Decimal to binary number conversion
strings MATLAB string handling cputime Elapsed CPU time
dec2hex Decimal to hexadecimal number conversion
date Current date string
hex2dec Hexadecimal to decimal number conversion
datenum Serial date number
String to Function Handle Conversion hex2num Hexadecimal to double number conversion
Date string format
datestr
func2str Constructs a function name string from a function handle
datevec Date components
str2func Constructs a function handle from a function name string Matrix Manipulation eomday End of month
Elementary Matrices and Arrays etime Elapsed time

String Manipulation blkdiag Construct a block diagonal matrix from input arguments now Current date and time
eye Identity matrix tic, toc Stopwatch timer
deblank Strip trailing blanks from the end of a string
linspace Generate linearly spaced vectors weekday Day of the week
findstr Find one string within another
logspace Generate logarithmically spaced vectors
lower Convert string to lower case
numel Number of elements in a matrix or cell array
strcat String concatenation Matrix Manipulation
ones Create an array of all ones
strcmp Compare strings Concatenate arrays
cat
rand Uniformly distributed random numbers and arrays
strcmpi Compare strings, ignoring case
diag Diagonal matrices and diagonals of a matrix
randn Normally distributed random numbers and arrays
strjust Justify a character array
fliplr Flip matrices left-right
zeros Create an array of all zeros
strmatch Find possible matches for a string
flipud Flip matrices up -down
repmat Replicate and tile an array Structure Functions sub2ind Single index from subscripts
reshape Reshape array fieldnames Field names of a structure
rot90 Rotate matrix 90 degrees getfield Get field of structure array Sound Processing Functions
tril Lower triangular part of a matrix rmfield Remove structure fields General Sound Functions
triu Upper triangular part of a matrix setfield Set field of structure array
lin2mu Convert linear audio signal to mu-law
: (colon) Index into array, rearrange array struct Create structure array
mu2lin Convert mu-law audio signal to linear
struct2cell Structure to cell array conversion
sound Convert vector into sound

Vector Functions soundsc Scale data and play as sound


MATLAB Object Functions
cross Vector cross product
class Create object or return class of object
dot Vector dot product SPARCstation-Specific Sound Functions
isa Detect an object of a given class
intersect Set intersection of two vectors
methods Display method names auread Read NeXT/SUN (.au) sound file
ismember Detect members of a set
Displays information on all methods implemented by auwrite Write NeXT/SUN (.au) sound file
Return the set difference of two vector methodsview a class
setdiff
setxor Set exclusive or of two vectors Overloaded method for A(I)=B, A{I}=B, and
subsasgn A.field=B
union Set union of two vectors .WAV Sound Functions
subsindex Overloaded method for X(A)
unique Unique elements of a vector wavplay Play recorded sound on a PC-based audio output device
subsref Overloaded method for A(I), A{I} and A.field
wavread Read Microsoft WAVE (.wav) sound file
Specialized Matrices wavrecord Record sound using a PC-based audio input device
compan Companion matrix Cell Array Functions wavwrite Write Microsoft WAVE (.wav) sound file
cell Create cell array
gallery Test matrices
cellfun Apply a function to each element in a cell array
hadamard Hadamard matrix File I/O Functions
cellstr Create cell array of strings from character array
hankel Hankel matrix File Opening and Closing
cell2struct Cell array to structure array conversion
hilb Hilbert matrix
fclose Close one or more open files
celldisp Display cell array contents
invhilb Inverse of the Hilbert matrix
fopen Open a file or obtain information about open files
Magic square cellplot Graphically display the structure of cell arrays
magic
num2cell Convert a numeric array into a cell array
pascal Pascal matrix
toeplitz Toeplitz matrix Unformatted I/O
wilkinson Wilkinson’s eigenvalue test matrix Multidimensional Array Functions fread Read binary data from file
cat Concatenate arrays
fwrite Write binary data to a file
flipdim Flip array along a specified dimension
Bitwise Functions
Bit-wise AND ind2sub Subscripts from linear index
bitand
bitcmp Complement bits Inverse permute the dimensions of a multidimensional Formatted I/O
ipermute array
fgetl Return the next line of a file as a string without line terminator(s)
bitor Bit-wise OR
Generate arrays for multidimensional functions and
ndgrid fgets Return the next line of a file as a string with line terminator(s)
bitmax Maximum floating-point integer interpolation
Set bit fprintf Write formatted data to file
bitset ndims Number of array dimensions
bitshift Bit-wise shift Rearrange the dimensions of a multidimensional array fscanf Read formatted data from file
permute
bitget Get bit reshape Reshape array
bitxor Bit-wise XOR shiftdim Shift dimensions File Positioning
squeeze Remove singleton dimensions
feof Test for end-of-file
ferror Query MATLAB about errors in file input or output rat, rats Rational fraction approximation hess Hessenberg form of a matrix
frewind Rewind an open file poly Polynomial with specified roots
fseek Set file position indicator Coordinate System Conversion qz QZ factorization for generalized eigenvalues
ftell Get file position indicator cart2pol Transform Cartesian coordinates to polar or cylindrical rsf2csf Convert real Schur form to complex Schur form
cart2sph Transform Cartesian coordinates to spherical schur Schur decomposition
pol2cart Transform polar or cylindrical coordinates to Cartesian svd Singular value decomposition
String Conversion Transform spherical coordinates to Cartesian
sph2cart
sprintf Write formatted data to a string
sscanf Read string under format control Matrix Functions
Matrix Functions
expm Matrix exponential
Matrix Analysis Evaluate general matrix function
funm
Specialized File I/O cond Condition number with respect to inversion Matrix logarithm
logm
dlmread Read an ASCII delimited file into a matrix condeig Condition number with respect to eigenvalues
Matrix square root
sqrtm
dlmwrite Write a matrix to an ASCII delimited file det Matrix determinant
hdf HDF interface norm Vector and matrix norms
imfinfo Return information about a graphics file null Null space of a matrix Low Level Functions
imread Read image from graphics file orth Range space of a matrix qrdelete Delete column from QR factorization
imwrite Write an image to a graphics file rank Rank of a matrix qrinsert Insert column in QR factorization
strread Read formatted data from a string rcond Matrix reciprocal condition number estimate
textread Read formatted data from text file rref, rrefmovie Reduced row echelon form Data Analysis and Fourier Transform
wk1read Read a Lotus123 WK1 spreadsheet file into a matrix subspace Angle between two subspaces Basic Operations
wk1writ Write a matrix to a Lotus123 WK1 spreadsheet file trace Sum of diagonal elements
cumprod Cumulative product
e
cumsum Cumulative sum

Linear Equations cumtrapz Cumulative trapezoidal numerical integration


Specialized Math Functions
factor Prime factors
airy Airy functions chol Cholesky factorization
inpolygon Detect points inside a polygonal region
Bessel functions of the third kind (Hankel inv Matrix inverse
besselh functions) Maximum elements of an array
Least squares solution in the presence of known max
Modified Bessel functions lscov covariance Average or mean value of arrays
besseli, besselk mean
besselj, bessely Bessel functions lu LU matrix factorization median Median value of arrays
beta, betainc, betaln Beta functions lsqnonneg Nonnegative least squares min Minimum elements of an array
ellipj Jacobi elliptic functions minres Minimum Residual Method perms All possible permutations
Complete elliptic integrals of the first and second pinv Moore-Penrose pseudoinverse of a matrix polyarea Area of polygon
ellipke kind
qr Orthogonal-triangular decomposition primes Generate list of prime numbers
erf, erfc, erfcx, Error functions Symmetric LQ method Product of array elements
symmlq prod
erfinv
rectint Rectangle intersection Area
expint Exponential integral
sort Sort elements in ascending order
factorial Factorial function Eigenvalues and Singular Values sortrows Sort rows in ascending order
gamma, gammainc, Gamma functions Improve accuracy of computed eigenvalues
balance Standard deviation
gammaln std
cdf2rdf Convert complex diagonal form to real block diagonal form
legendre Associated Legendre functions sum Sum of array elements
eig Eigenvalues and eigenvectors
pow2 Base 2 power and scale floating-point numbers trapz Trapezoidal numerical integration
gsvd Generalized singular value decomposition
var Variance poly Polynomial with specified roots Function Functions - Nonlinear Numerical
polyder Polynomial derivative Methods
polyeig Polynomial eigenvalue problem Solve two-point boundry value problems (BVPs)
Finite Differences bvp4c for ordinary differential equations (ODEs)
polyfit Polynomial curve fitting
del2 Discrete Laplacian bvpget Extract parameters from BVP options structure
polyint Analytic polynomial integration
diff Differences and approximate derivatives bvpinit Form the initial guess for bvp4c
polyval Polynomial evaluation
gradient Numerical gradient bvpset Create/alter BVP options structure
polyvalm Matrix polynomial evaluat ion
Convert between partial fraction expansion and polynomial bvpval Evaluate the solution computed by bvp4c
residue
coefficients dblquad Numerical evaluation of double integrals
Correlation Polynomial roots Minimize a function of one variable
roots fminbnd
corrcoef Correlation coefficients
fminsearch Minimize a function of several variables
cov Covariance matrix
fzero Find zero of a function of one variable
Data Interpolation
ode45, ode23,
convhull Convex hull ode113, ode15s,
Filtering and Convolution Solve initial value problems for ODEs
ode23s, ode23t,
convhulln Multidimensional convex hull
conv Convolution and polynomial multiplication ode23tb
delaunay Delaunay triangulation
odeget Extract parameters from ODE options structure
conv2 Two-dimensional convolution
delaunay3 Three-dimensionalDelaunay tessellation Create/alter ODE options structure
Deconvolution and polynomial division odeset
deconv
delaunayn Multidimensional Delaunay tessellation Get optimization options structure parameter
Filter data with an infinite impulse response (IIR) or finite optimget
filter dsearch Search for nearest point values
impulse response (FIR) filter
dsearchn Multidimensional closest point search Create or edit optimization options parameter
filter2 Two-dimensional digital filtering optimset structure
griddata Data gridding
Data gridding and hypersurface fitting for three-dimensional pdepe Solve initial-boundary value problems
griddata3 data
Fourier Transforms pdeval Evaluate the solution computed by pdepe

Absolute value and complex magnitude griddatan Data gridding and hypersurface fitting (dimension >= 2) Numerical evaluation of integrals, adaptive
abs quad Simpson quadrature
interp1 One-dimensional data interpolation (table lookup)
angle Phase angle
Two-dimensional data interpolation (table lookup) Numerical evaluation of integrals, adaptive Lobatto
Sort complex numbers into complex conjugate pairs interp2 quadl
cplxpair quadrature
interp3 Three-dimensional data interpolation (table lookup)
fft One-dimensional fast Fourier transform vectorize Vectorize expression
interpft One-dimensional interpolation using the FFT method
fft2 Two-dimensional fast Fourier transform
interpn Multidimensional data interpolation (table lookup)
fftshift
Shift DC component of fast Fourier transform to center of Sparse Matrix Functions
spectrum meshgrid Generate X and Y matrices for three-dimensional plots
Inverse one-dimensional fast Fourier transform Generate arrays for multidimensional functions and
Elementary Sparse Matrices
ifft ndgrid
interpolation spdiags Extract and create sparse band and diagonal matrices
ifft2 Inverse two-dimensional fast Fourier transform
pchip Piecewise Cubic Hermite Interpolating Polynomial (PCHIP) speye Sparse identity matrix
ifftn Inverse multidimensional fast Fourier transform
ppval Piecewise polynomial evaluation sprand Sparse uniformly distributed random matrix
ifftshift Inverse FFT shift
spline Cubic spline data interpolation sprandn Sparse normally distributed random matrix
nextpow2 Next power of two
tsearch Search for enclosing Delaunay triangle sprandsym Sparse symmetric random matrix
unwrap Correct phase angles
tsearchn Multidimensional closest simplex search
voronoi Voronoi diagram
Polynomial and Interpolation Functions Full to Sparse Conversion
voronoin Multidimensional Voronoi diagrams
Polynomials find Find indices and values of nonzero elements
conv Convolution and polynomial multiplication full Convert sparse matrix to full matrix
deconv Deconvolution and polynomial division sparse Create sparse matrix
spconvert Import matrix from sparse matrix external format luinc Incomplete LU matrix factorizations slice Volumetric slice plot
pcg Preconditioned Conjugate Gradients method sphere Generate sphere
qmr Quasi-Minimal Residual method stem3 Plot discrete surface data
Working with Nonzero Entries Orthogonal-triangular decomposition Waterfall plot
qr waterfall
nnz Number of nonzero matrix elements
qrdelete Delete column from QR factorization
nonzeros Nonzero matrix elements
qrinsert Insert column in QR factorization
nzmax Amount of storage allocated for nonzero matrix elements
Rank 1 update to QR factorization
Plot Annotation and Grids
qrupdate
spalloc Allocate space for sparse matrix clabel Add contour labels to a contour plot
spfun Apply function to nonzero sparse matrix elements datetick Date formatted tick labels
spones Replace nonzero sparse matrix elements with ones Sparse Eigenvalues and Singular Values grid Grid lines for 2-D and 3-D plots
eigs Find eigenvalues and eigenvectors gtext Place text on a 2-D graph using a mouse
svds Find singular values legend Graph legend for lines and patches
Visualizing Sparse Matrices
plotyy Plot graphs with Y tick labels on the left and right
spy Visualize sparsity pattern
title Titles for 2-D and 3-D plots
Miscellaneous X-axis labels for 2-D and 3-D plots
xlabel
spparms Set parameters for sparse matrix routines
ylabel Y-axis labels for 2-D and 3-D plots
Reordering Algorithms
zlabel Z-axis labels for 3-D plots
colamd Column approximate minimum degree permutation
Plotting and Data Visualization
colmmd Sparse column minimum degree permutation
Sparse column permutation based on nonzero count
Basic Plots and Graphs
colperm Surface, Mesh, and Contour Plots
bar Vertical bar chart
dmperm Dulmage-Mendelsohn decomposition
contour Contour (level curves) plot
barh Horizontal bar chart
randperm Random permutation Contour computation
Plot histograms contourc
Symmetric approximate minimum degree permutation hist
symamd Filled contour plot
contourf
histc Histogram count
symmmd Sparse symmetric minimum degree ordering
hidden Mesh hidden line removal mode
hold Hold current graph
symrcm Sparse reverse Cuthill-McKee ordering
meshc Combination mesh/contourplot
loglog Plot using log-log scales
mesh 3-D mesh with reference plane
pie Pie plot
Norm, Condition Number, and Rank peaks A sample function of two variables
plot Plot vectors or matrices.
surf 3-D shaded surface graph
condest 1-norm matrix condition number estimate polar Polar coordinate plot
surface Create surface low-level objects
normest 2-norm estimate semilogx Semi-log scale plot
surfc Combination surf/contourplot
semilogy Semi-log scale plot
surfl 3-D shaded surface with lighting
subplot Create axes in tiled positions
Sparse Systems of Linear Equations trimesh Triangular mesh plot
bicg BiConjugate Gradients method trisurf Triangular surface plot
bicgstab BiConjugate Gradients Stabilized method Three-Dimensional Plotting
cgs Conjugate Gradients Squared method bar3 Vertical 3-D bar chart
Sparse Incomplete Cholesky and Cholesky-Infinity Horizontal 3-D bar chart
Volume Visualization
bar3h
cholinc factorizations Plot velocity vectors as cones in 3-D vector field
3-D comet plot coneplot
comet3
cholupdate Rank 1 update to Cholesky factorization contourslice Draw contours in volume slice plane
cylinder Generate cylinder
gmres Generalized Minimum Residual method (with restarts) Compute the curl and angular velocity of a vector
fill3 Draw filled 3-D polygons in 3-space curl
field
LSQR implementation of Conjugate Gradients on the normal
lsqr plot3 Plot lines and points in 3-D space
equations divergence Compute the divergence of a vector field
quiver3 3-D quiver (or velocity) plot
flow Generate scalar volume data ezplot3 Easy to use 3-D parametric curve plotter pbaspect Set or get plot box aspect ratio
Interpolate streamline vertices from vector-field ezpolar Easy to use polar coordinate plotter view 3-D graph viewpoint specification.
interpstreamspeed magnitudes
ezsurf Easy to use 3-D colored surface plotter viewmtx Generate view transformation matrices
isocaps Compute isosurface end-cap geometry
ezsurfc Easy to use combination surface/contour plotter xlim Set or get the current x-axis limits
isocolors Compute the colors of isosurface vertices
feather Feather plot ylim Set or get the current y-axis limits
isonormals Compute normals of isosurface vertices
fill Draw filled 2-D polygons zlim Set or get the current z-axis limits
isosurface Extract isosurface data from volume data
fplot Plot a function
reducepatch Reduce the number of patch faces
pareto Pareto char
reducevolume Reduce number of elements in volume data set Lighting
pie3 3-D pie plot
shrinkfaces Reduce the size of patch faces camlight Cerate or position Light
plotmatrix Scatter plot matrix
slice Draw slice planes in volume light Light object creation function
pcolor Pseudocolor (checkerboard) plot
smooth3 Smooth 3-D data lighting Lighting mode
rose Plot rose or angle histogram
stream2 Compute 2-D stream line data lightangle Position light in sphereical coordinates
quiver Quiver (or velocity) plot
stream3 Compute 3-D stream line data material Material reflectance mode
ribbon Ribbon plot
streamline Draw stream lines from 2- or 3-D vector data
stairs Stairstep graph
streamparticles Draws stream particles from vector volume data
scatter Scatter plot
Draws stream ribbons from vector volume data
Transparency
streamribbon 3-D scatter plot
scatter3 Set or query transparency properties for objects in
Draws well-spaced stream lines from vector alpha
streamslice stem Plot discrete sequence data current axes
volume data
convhull Convex hull alphamap Specify the figure alphamap
streamtube Draws stream tubes from vector volume data
delaunay Delaunay triangulation alim Set or query the axes alpha limits
surf2patch Convert srface data to patch data
dsearch Search Delaunay triangulation for nearest point
subvolume Extract subset of volume data set
inpolygon True for points inside a polygonal region
Return coordinate and color limits for volume Color Operations
volumebounds Area of polygon
(scalar and vector) polyarea
brighten Brighten or darken color map
tsearch Search for enclosing Delaunay triangle
caxis Pseudocolor axis scaling
voronoi Voronoi diagram
Domain Generation colorbar Display color bar (color scale)
griddata Data gridding and surface fitting colordef Set up color defaults
meshgrid Generation of X and Y arrays for 3-D plots View Control colormap Set the color look-up table (list of colormaps)
camdolly Move camera position and target graymon Graphics figure defaults set for grayscale monitor
camlookat View specific objects hsv2rgb Hue-saturation-value to red-green-blue conversion
Specialized Plotting camorbit Orbit about camera target RGB to HSVconversion
rgb2hsv
area Area plot
campan Rotate camera target about camera position rgbplot Plot color map
box Axis box for 2-D and 3-D plots
campos Set or get camera position shading Color shading mode
comet Comet plot
camproj Set or get projection type spinmap Spin the colormap
compass Compass plot Rotate camera about viewing axis
camroll surfnorm 3-D surface normals
errorbar Plot graph with error bars
camtarget Set or get camera target whitebg Change axes background color for plots
ezcontour Easy to use contour plotter
camup Set or get camera up-vector
ezcontourf Easy to use filled contour plotter
camva Set or get camera view angle
ezmesh Easy to use 3-D mesh plotter
camzoom Zoom camera in or out
Colormaps
ezmeshc Easy to use combination mesh/contour plotter autumn Shades of red and yellow color map
daspect Set or get data aspect ratio
ezplot Easy to use function plotter bone Gray-scale with a tinge of blue color map
contrast Gray color map to enhance image contrast setappdata Specify application data
cool Shades of cyan and magenta color map
Linear copper-tone color map
Interactive User Input
copper
Alternating red, white, blue, and black color map
Handle Graphics, Object Creation ginput Graphical input from a mouse or cursor
flag
axes Create Axes object zoom Zoom in and out on a 2-D plot
gray Linear gray-scale color map
figure Create Figure (graph) windows
hot Black-red-yellow-white color map
image Create Image (2-D matrix)
hsv Hue-saturation-value (HSV) color map Region of Interest
light Create Light object (illuminates Patch and Surface)
jet Variant of HSV
dragrect Drag XOR rectangles with mouse
line Create Line object (3-D polylines)
lines Line color colormap
drawnow Complete any pending drawing
patch Create Patch object (polygons)
prism Colormap of prism colors
rbbox Rubberband box
rectangle Create Rectangle object (2-D rectangle)
spring Shades of magenta and yellow color map
surface Create Surface (quadrilaterals)
summer Shades of green and yellow colormap
text Create Text object (character strings) Graphical User Interfaces
winter Shades of blue and green color map
uicontextmenu Create context menu (popup associated with object) Dialog Boxes
dialog Create a dialog box
Printing errordlg Create error dialog box
orient Hardcopy paper orientation helpdlg Display help dialog box
pagesetupdlg Page position dialog box inputdlg Create input dialog box
print Print graph or save graph to file listdlg Create list selection dialog box
printdlg Print dialog box Handle Graphics, Figure Windows msgbox Create message dialog box
Configure local printer defaults capture Screen capture of the current figure Display page layout dialog box
printopt pagedlg
Save figure to graphic file clc Clear figure window Display print dialog box
saveas printdlg
clf Clear figure Create question dialog box
questdlg
close Close specified window Display dialog box to retrieve name of file for reading
uigetfile
Handle Graphics, General closereq Default close request function Display dialog box to retrieve name of file for writing
uiputfile
allchild Find all children of specified objects gcf Get current figure handle
uisetcolor Interactively set a ColorSpec using a dialog box
copyobj Make a copy of a graphics object and its children newplot Graphics M-file preamble for NextPlot property
uisetfont Interactively set a font using a dialog box
findall Find all graphics objects (including hidden handles) refresh Refresh figure
warndlg Create warning dialog box
findobj Find objects with specified property values saveas Save figure or model to desired output format
gcbo Return object whose callback is currently executing
gco Return handle of current object User Interface Deployment
get Get object properties
Handle Graphics, Axes guidata Store or retrieve application data
Rotate objects about specified origin and direction axis Plot axis scaling and appearance Create a structure of handles
rotate guihandles
ishandle True for graphics objects cla Clear Axes Move GUI figure onscreen
movegui
set Set object properties gca Get current Axes handle Open or raise GUI figure
openfig

Working with Application Data Object Manipulation User Interface Development


getappdata Get value of application data reset Reset axis or figure Open the GUI Layout Editor
guide
True if applicat ion data exists rotate3d Interactively rotate the view of a 3-D plot Display Property Inspector
isappdata inspect
rmappdata Remove application data selectmoveresize Interactively select, move, or resize objects
MATLAB Interface to Java mexWarnMsgTxt Issue warning message mxGetCell Get cell's contents
class Create object or return class of object mxGetClassID Get mxArray's class
import Add a package or class to the current Java import list mxGetClassName Get mxArray's class
Detect an object of a given class
C MX Functions Get pointer to data
isa mxGetData
mxAddField Add field to structure array
isjava Test whether an object is a Java object mxGetDimensions Get pointer to dimensions array
mxArrayToString Convert arrays to strings
javaArray Constructs a Java array mxGetElementSize Get number of bytes required to store each
mxAssert Check assertion value data element
javaMethod Invokes a Java method
mxAssertS Check assertion value; doesn't print mxGetEps Get value of eps
javaObject Constructs a Java object
assertion's text
mxGetField Get field value, given field name and index in
methods Display method names
mxCalcSingleSubscript Return offset from first element to desired structure array
Displays information on all methods implemented by a element
methodsview class mxGetFieldByNumber Get field value, given field number and index
mxCalloc Allocate dynamic memory in structure array
mxChar String mxArrays data type mxGetFieldNameByNum Get field name, given field number in
External Programming Interface mxClassID Enumerated data type that identifies ber structure array

C MEX-Functions mxArray's class mxGetFieldNumber Get field number, given field name in
structure array
mxClearLogical Clear logical flag
mexAtExit Register function to be called when
mxGetImagData Get pointer to imaginary data of mxArray
MATLAB is cleared or terminates mxComplexity Specifies if mxArray has imaginary
components mxGetInf Get value of infinity
mexCallMATLAB Call MATLAB function or user-defined M-
file or MEX-file mxCreateCellArray Create unpopulated N-dimensional cell mxGetIr Get ir array of sparse matrix
mxArray
mexErrMsgTxt Issue error message and return to MATLAB mxGetJc Get jc array of sparse matrix
mxCreateCellMatrix Create unpopulated two-dimensional cell
mexEvalString Execute MATLAB command in caller's mxGetM Get number of rows
mxArray
workspace
mxGetN Get number of columns or number of
mxCreateCharArray Create unpopulated N-dimensional string
mexFunction Entry point to C MEX-file elements
mxArray
mexFunctionName Name of current MEX-function mxGetName Get name of specified mxArray
mxCreateCharMatrixFr Create populated t wo-dimensional string
mexGet Get value of Handle Graphics property omStrings mxArray mxGetNaN Get the value of NaN
mexGetArray Get copy of variable from another workspace mxCreateDoubleMatrix Create unpopulated two-dimensional, double- mxGetNumberOfDimens Get number of dimensions
precision, floating-point mxArray ions
mexGetArrayPtr Get read-only pointer to variable from
another workspace mxCreateNumericArray Create unpopulated N-dimensional numeric mxGetNumbe rOfElemen Get number of elements in array
mxArray ts
mexIsGlobal True if mxArray has global scope
True if MEX-file is locked mxCreateNumericMatrix Create numeric matrix and initialize data mxGetNumberOfFields Get number of fields in structure mxArray
mexIsLocked
elements to 0 Get number of elements in ir, pr, and pi
mxGetNzmax
mexLock Lock MEX-file so it cannot be cleared from
mxCreateScalarDouble Create scalar, double-precision array arrays
memory
initialized to specified value
mxGetPi Get mxArray's imaginary data elements
mexMakeArrayPersisten Make mxArray persist after MEX-file Create two-dimensional unpopulated sparse
completes mxCreateSparse Get mxArray's real data elements
t mxGetPr
mxArray
mexMakeMemoryPersist Make memory allocated by MATLAB's mxGetScalar Get real component of mxArray's first data
mxCreateString Create 1-by-n string mxArray initialized to
ent memory allocation routines persist after element
specified strin g
MEX-file completes
mxGetString Copy string mxArray's data into C-style
mxCreateStructArray Create unpopulated N-dimensional structure
mexPrintf ANSI C printf-style output routine string
mxArray
mexPutArray Copy mxArray from your MEX-file into mxIsCell True if cell mxArray
mxCreateStructMatrix Create unpopulated two-dimensional
another workspace
structure mxArray mxIsChar True if string mxArray
mexSet Set value of Handle Graphics property
mxDestroyArray Free dynamic memory allocated by an mxIsClass True if mxArray is member of specified class
mexSetTrapFlag Control response of mexCallMATLAB to mxCreate routine True if data is complex
mxIsComplex
errors
mxDuplicateArray Make deep copy of array
mxIsDouble True if mxArray represents its data as double-
mexUnlock Unlock MEX-file so it can be cleared from
mxFree Free dynamic memory allocated by mxCalloc precision, floating-point numbers
memory
mxIsEmpty True if mxArray is empty mxSetN Set number of columns fread Read binary data from the device
mxIsFinite True if value is finite mxSetName Set name of mxArray fscanf Read data from the device, and format as text
mxIsFromGlobalWS True if mxArray was copied from mxSetNzmax Set storage space for nonzero elements fwrite Write binary data to the device
MATLAB's global workspace
mxSetPi Set new imaginary data for mxArray readasync Read data asynchronously from the device
mxIsInf True if value is infinite
mxSetPr Set new real data for mxArray stopasync Stop asynchronous read and write operations
mxIsInt8 True if mxArray represents its data as signed
8-bit integers
mxIsInt16 True if mxArray represents its data as signed C Engine Routines Configuring and Returning Properties
16-bit integers
engClose Quit engine session get Return serial port object properties
mxIsInt32 True if mxArray represents its data as signed
32-bit integers engEvalString Evaluate expression in string set Configure or display serial port object properties
mxIsLogical True if mxArray is Boolean engGetArray Copy variable from engine workspace
mxIsNaN True if value is NaN engOpen Start engine session
State Change
mxIsNumeric True if mxArray is numeric engOpenSingleUse Start engine session for single, nonshared use
fclose Disconnect a serial port object from the device
mxIsSingle True if mxArray represents its data as single- engOutputBuffer Specify buffer for MATLAB output
precision, floating-point numbers fopen Connect a serial port object to the device
engPutArray Put variables into engine workspace
mxIsSparse True if sparse mxArray record Record data and event information to a file
mxIsStruct True if structure mxArray
mxIsUint8 True if mxArray represents its data as C MAT-File Routines
unsigned 8-bit integers
Close MAT-file
General Purpose
matClose
mxIsUint16 True if mxArray represents its data as clear Remove a serial port object from the MATLAB workspace
matDeleteArray Delete named mxArray from MAT -file
unsigned 16-bit integers
delete Remove a serial port object from memory
matGetArray Read mxArray from MAT-file
mxIsUint32 True if mxArray represents its data as
disp Display serial port object summary information
unsigned 32-bit integers matGetArrayHeader Load header array information only
Get directory of mxArrays in MAT-file instraction Display event information when an event occurs
mxMalloc Allocate dynamic memory using MATLAB's matGetDir
memory manager Return serial port objects from memory to the MATLAB
matGetFp Get file pointer to MAT-file instrfind workspace
mxRealloc Reallocate memory
matGetNextArray Read next mxArray from MAT -file
isvalid Determine if serial port objects are valid
mxRemoveField Remove field from structure array Load array header information only
matGetNextArrayHeader Length of serial port object array
length
mxSetAllocFcns Register memory allocation/deallocation Open MAT-file
matOpen
functions in stand-alone engine or MAT Load serial port objects and variables into the MATLAB
application Write mxArrays into MAT-files load workspace
matPutArray
mxSetCell Set value of one cell matPutArrayAsGlobal Put mxArrays into MAT-files save Save serial port objects and variables to a MAT-file
mxSetClassName Convert MATLAB structure array to serialbreak Send a break to the device connected to the serial port
MATLAB object array
Serial Port I/O size Size of serial port object array
mxSetData Set pointer to data
Creating a Serial Port Object
mxSetDimensions Modify number/size of dimensions
serial Create a serial port object Handle Graphic Properties
mxSetField Set field value of structure array, given field
name/index Root
mxSetFieldByNumber Set field value in structure array, given field ButtonDownFcn; CallbackObject; Children; Clipping; CreateFcn;
number/index Writing and Reading Data CurrentFigure; DeleteFcn; Diary; DiaryFile; Echo; ErrorMessage;
Set imaginary data pointer for mxArray Read one line of text from the device and discard the FixedWidthFontName; Format; FormatSpacing; HandleVisibility;
mxSetImagData fgetl
terminator HitTest; Interruptible; Language; Parent; PointerLocation;
mxSetIr Set ir array of sparse mxArray PointerWindow; Profile; ProfileCount; ProfileFile; ProfileInterval;
Read one line of text from the device and include the ScreenDepth; ScreenSize; Selected; SelectionHighlight;
mxSetJc Set jc array of sparse mxArray fgets terminator ShowHiddenHandles; Tag; Type; UIContextMenu; Units; UserData;
mxSetLogical Set logical flag Write text to the device Visible
fprintf
mxSetM Set number of rows
Figure BackgroundColor; BusyAction; ButtonDownFcn; Callback; CData;
Children; Clipping; CreateFcn; DeleteFcn; Enable; Extent;
AlphaMap; BackingStore; BusyAction; ButtonDownFcn; Children; FontAngle; FontName; FontSize; FontUnits; FontWeight;
Clipping; CloseRequestFcn; Color; Colormap; CreateFcn; ForegroundColor; HandleVisibility; HitTest; HorizontalAlignment;
CurrentAxes; CurrentCharacter; CurrentObject; CurrentPoint; Interruptible; ListboxTop; Max; Min; Parent; Position; Selected;
DeleteFcn; Dithermap; DithermapMode; DoubleBuffer; FixedColors; SelectionHighlight; SliderStep; String; Style; Tag; TooltipString;
HandleVisibility; HitTest; IntegerHandle; Interruptible; Type; UIContextMenu; Units; UserData; Value; Visible
InvertHardcopy; KeyPressFcn; MenuBar; MinColormap; Name;
NextPlot; NumberTitle; PaperOrientation; PaperPosition;
PaperPositionMode; PaperSize; PaperType; PaperUnits; Parent; Uimenu
Pointer; PointerShapeCData; PointerShapeHotSpot; Position;
Renderer; RendererMode; Resize; ResizeFcn; Selected; Accelerator; BusyAction; ButtonDownFcn; Callback; Checked;
SelectionHighlight; SelectionType; ShareColors; Tag; Type; Children; Clipping; CreateFcn; DeleteFcn; Enable;
UIContextMenu; Units; UserData; Visible; WindowButtonDownFcn; ForegroundColor; HandleVisibility; HitTest; Interruptible; Label;
WindowButtonMotionFcn; WindowButtonUpFcn; WindowStyle Parent; Position; Selected; SelectionHighlight; Separator; Tag; Type;
UIContextMenu; UserData; Visible

Axes
ALim; ALimMode; AmbientLightColor; Box; BusyAction;
ButtonDownFcn; CLim; CLimMode; CameraPosition;
CameraPositionMode; CameraTarget; CameraTargetMode;
CameraUpVector; CameraUpVectorMo de; CameraViewAngle;
CameraViewAngleMode; Children; Clipping; Color; ColorOrder;
CreateFcn; CurrentPoint; DataAspectRatio; DataAspectRatioMode;
DeleteFcn; DrawMode; FontAngle; FontName; FontSize; FontUnits;
FontWeight; GridLineStyle; HandleVisibility; HitTest; Interruptible;
Layer; LineStyleOrder; LineWidth; NextPlot; Parent;
PlotBoxAspectRatio; PlotBoxAspectRatioMode; Position; Projection;
Selected; SelectionHighlight; Tag; TickDir; TickDirMode;
TickLength; Title; Type; Units; UIContextMenu; UserData; View;
Visible; XAxisLocation; XColor; Xdir; XGrid; XLabel; XLim;
XLimMode; XScale; XTick; XTickLabel; XTickLabelMode;
XTickMode; YAxisLocation; YColor; YDir; YGrid; YLabel; YLim;
YLimMode; YScale; YTick; YTickLabel; YTickLabelMode;
YTickMode; ZColor; ZDir; ZGrid; ZLabel; ZLim; ZLimMode;
ZScale; ZTick; ZTickLabel; ZTickLabelMode; ZtickMode

Line
BusyAction; ButtonDownFcn; Children; Clipping; Color; CreateFcn;
DeleteFcn; EraseMode; HandleVisibility; HitTest; Interruptible;
LineStyle; LineWidth; Marker; MarkerEdgeColor;
MarkerFaceColor; MarkerSize; Parent; Selected; SelectionHighlight;
Tag; Type; UIContextMenu; UserData; Visible; XData; YData;
ZData

Text
BusyAction; ButtonDownFcn; Children; Clipping; Color; CreateFcn;
DeleteFcn; Editing; EraseMode; Extent; FontAngle; FontName;
FontSize; FontUnits; FontWeight; HandleVisibility; HitTest;
HorizontalAlignment; Interpreter; Interruptible; Parent; Position;
Rotation; Selected; SelectionHighlight; String; Tag; Type;
UIContextMenu; Units; UserData; VerticalAlignment; Visible

Uicontrol

You might also like