You are on page 1of 140

Basic functions

These are the basic calculator functions :


Plus or Add : + Minus or Subtract : Multiply : * Divide : /

Examples

Mod(m,n)
Mod(m,n) calculates m-n*floor(m/n)

The sign of Mod(m,n) always equals the sign of n

Sqrt(z)
sqrt(z) takes the square root of a given number. Number can be either real or complex. There are different ways to enter this function :

directly as : sqrt() keyboard shortcut : CTRL + SHIFT + R through dedicated key :

Power (^)
The power function ^ raises a given number to the given power.

Examples

NRoot(z,n)
nRoot(z, n, [mode]) finds the nth root of a given value.

n = root z = input value, either real or complex mode = 0 : returns ONLY real roots (except for complex z) mode = 1 : returns ALL roots, real and complex

All roots are returned in a list

Examples

Factorial(n) or n!
Factorial(n), also written as n!, returns the number of ways n elements can be ordered.

n! = 1 * 2 * 3 * ..... (n-1) * n

NCr(n,r)
nCr(n,r) returns the number of unordered subsets of r elements out of a set of n elements

nCr(n,r) = n! / ((n-r)! * r!)

NPr(n,r)
nPr(n,r) returns the number of permutations of a subset of r elements from a set of n elements

nPr(n,r) = n! / (n-r)!

Binomial(n,r)
Binomial(n,r) finds the binomial coefficient. Binomial(n,r) can be used with symbolic and numerical values. This function is equivalent as the function nCr(n,r) which can only be used with numerical values.

Examples

Multinomial(nList)
Multinomial([nList]) finds the Multinomial coefficient of nList.

Examples

Pochhammer(n,k)
Pochhammer(n,k) finds the value of n*(n+1)*(n+2)*..*(n+k-1)

Examples

Floor(z)
Floor(z) returns the greatest integer of the given value. If z is a complex number, then floor works on both the real and the imaginary part.

Examples

Ceil(z)
Ceil(z) returns the smallest integer of the given value. If z is a complex number, then ceil works on both the real and the imaginary part.

Examples

Sign(z)
Sign(z) returns the sign of a given value. If z is a complex number, then sign returns z/abs(z).

Examples

FPart(x)
fPart(x) returns the fractional part of x.

Examples

Round(number, digits)
Round(number, digits) rounds a given a given number to the requested number of digits.

Examples

z can be a real or complex value. In case of a complex value, both real & imaginary part will be rounded. Please note that the maximum displayed number of digits can never exceed the Options setting : Precision

Re(z)
Re(z) returns the real part of a complex number.

Im(z)
Im(z) returns the imaginary part of a complex number.

Abs(z)
Abs(z) returns the complex modulus (or magnitude) of a complex number.

Arg(z)
Arg(z) returns the argument (or phase) of a complex number.

Arg(z) returns the value in radians when Options - Angles - Radians is set, in degrees otherwise.

Example

Conj(z)
Conj(z) returns the complex conjugate of a complex number.

Exp(z) or e^(z)
exp(z) or e^z raises e (base of natural logarithm) to the power z. This function can be entered as:

directly : exp() keyboard shortcut : CTRL + SHIFT + e followed by ^ decdicated key e followed by ^

Examples

Ln(z)
ln(z) takes the natural logarithm (base: e) of the given number z. z can be either real or complex.

Examples

Log(z)
log(z) takes the common or Briggs logarithm (base: 10) of the given number z. z can be either real or complex.

[edit] Examples

Log(n,z)
log(n,z) takes the logarithm with base: n of the given number z. z can be either real or complex.

Examples

TrigExpand(function)
TrigExpand(function) splits up sums and integer multiples that appear in arguments of trigonometric functions and expands products of trigonometric functions into sums of powers.

Examples

TrigReduce(function)
TrigReduce(function) rewrites products and powers of trigonometric functions in expr in terms of trigonometric functions with combined arguments.

Examples

TrigCollect(function)
TrigCollect(function) is equivalent as TrigReduce(function), but even further reduces trigonometric functions.

Examples

TrigConvert(function)
TrigConvert(function) convert trigonometric functions to exponential functions.

Examples

ExpConvert(function)
ExpConvert(function) convert exponential functions to trigonometric functions.

Examples

TrigSolve(f(z),z)
TrigSolve(function, [var], [range]) can solve single trigonometric equations in one variable.

Function is the equation to be solved var is an optional parameter and indicates the variable used range indicates the range in which the answers should be returned : 0=[0,2Pi] (=default) or 1=[Pi,+Pi] If no equal sign is found in the equation, then SpaceTime assumes the equation to be equal to 0 The argument of the trigonometric functions can be of the form a*var + b in which a is an integer, var is the variable to solve and b any real number. SpaceTime returns the answer in radians or degrees depending on the angle settings. If no solution can be found, then SpaceTime either returns an error message or calls nSolve to find the closest solution to zero.

SpaceTime automatically calls TrigSolve() when Solve() is used !

Examples

Basic Trigonometric functions


Sin(z), Cos(z), Tan(z) are the basic trigonometric (or circular) functions.

Variable z can be either real or complex. SpaceTime 3.0 automatically converts sin(z)/cos(z) to tan(z) When you are in degree mode, then you don't need to add the degree symbol.

Examples

Basic Inverse Trigonometric functions


Asin(z), Acos(z), aTan(z) are the basic inverse trigonometric functions. Variable z can be either real or complex. Depending on the Option setting "Angles", the result is returned in radians or degrees.

Examples

Auxiliary Trigonometric functions


Csc(z), Sec(z), Cot(z) are the auxiliary trigonometric functions. Variable z can be either real or complex.

Examples

Auxiliary Inverse Trigonometric functions


Acscz), Asec(z), Acot(z) are the auxiliary inverse trigonometric functions. Variable z can be either real or complex. Depending on the Option setting "Angles", the result is returned in radians or degrees.

Examples

Basic Hyperbolic functions


Sinh(z), Cosh(z), Tanh(z) are the basic huperbolic functions. Variable z can be either real or complex. SpaceTime 3.0 automatically converts sinh(z)/cosh(z) to tanh(z)

Basic Inverse Hyperbolic functions


Asinh(z), Acosh(z), Atanh(z) are the basic inverse hyperbolic functions. Variable z can be either real or complex.

Auxiliary Hyperbolic functions


Csch(z), Sech(z), Coth(z) are the auxiliary hyperbolic functions. Variable z can be either real or complex.

Auxiliary Inverse Hyperbolic functions


Acscz), Asec(z), Acot(z) are the auxiliary inverse hyperbolic functions. Variable z can be either real or complex.

Random(min, max)
Random(min, max) generates a random number between min and max.

Examples

Bernoulli(n)
Bernoulli(n) returns the Bernoulli number n. n should be >= 0

Examples

Euler(n)
Euler(n) returns the Euler number n. n should be >= 0

Examples

Catalan(n)
Returns the nth Catalan number .

Examples

Fibonacci(n)
This functions returns the Fibonacci number of n.

Lucas(n)
Returns the nth Lucas number.

NFactors(n)
nFactors(n) is used to find all dividing factors of the given number n. The result is given as a list

Examples

NPrimes(n)
nPrimes(n) finds all prime factors and their exponent of a given number. The result is returned as a double list. The first number is the prime factor and the second number is the exponent.

Examples

Prime(n,p)
Prime(n,[p]) returns n prime numbers starting at prime number p. The parameter p is optional and set to 1 if not given. The greatest stored prime number is 12553 (p=1500)

Examples

IsPrime(n)
IsPrime(n) checks if the given number is a prime number.

returns 1 (true) if prime returns 0 (false) if not prime returns -1 when n > 157 425 000 (max value of n)

Examples

Expand(function)
Expand(function) returns the expanded form of a function.

Examples

Together(function)
Together(function) finds a common denominator for each additive term of a polynomial function and returns an equivalent expression with one numerator and one denominator. It performs the opposite operation as Apart(function).

Examples

Apart(function)
Apart(function, [var]) performs partial fraction decomposition on the polynomial function. It performs the opposite operation as Together(function). (Some CAS systems call this function PropFrac(function) )

Examples

Factor(function)
Factor(function) returns the factored form of a polynomial. It does the reverse of what Expand() does, but limited to polynomials. For polynomials of degree > 2 this function makes use of pSolve. If pSolve can find real roots, then Factor(function) can return a factored form of the given function.

Examples

SimplifyPoly(function)
SimplifyPoly( f(x)/g(x) ,[var] ) can simplify polynomial quotients f(x)/g(x) by factoring the numerator f(x), the denominator g(x) and then calculating the final factored form.

function can be of any form : f(x) , f(x)/g(x) , f(x)^n/g(x) , f(x)/g(x)^n var is an optional parameter indicating the used variable. If not given, SpaceTime searches for the correct variable. SimplifyPoly is making use of pSolve to find the real and imaginary roots of the given polynomial quotient. If pSolve can find the roots, then SimplifyPoly can return a factored form of the function.

Examples

Solve(f(z),z)
Solve(f(z),z) solves the given function(s) by separating the variable(s). This function has been extended since revision V3.0.3

Solve() can either be used to solve o single polynomial functions in one variable, in that case pSolve() is automatically called o single trigonometric equations in one variable, in that case TrigSolve() is automatically called o non regular equations in one variable, in that case nSolve() is automatically called o set of simultanious equations When solving a set of simultanious equations, separate them by a comma. When no equal sign is found in the given function, then SpaceTime assumes the equation equals zero.

Examples

PSolve(f(z),z)
pSolve(f(z), var) solves Polynomial equations numerically

pSolve returns all roots (both real and complex) of the given function in a list. Even multiple roots are all returned. f(z) can be any polynomial with real and/or complex coefficients. If f(z) is not an equation, then SpaceTime assumes f(z)=0 var is the used variable In general, for polynomials not having multiple roots, the returned accuracy is about 14 to 16 digits. In case of multiple roots, the accuracy goes down unless the returned root is an integer (both real or complex) or an exact fraction.

If you need to solve either first, second or third degree polynomials, then Solve(f(z),z) is a lot faster. If you need to solve non-polynomial equations, then use nSolve(f(z),z,guess)

Examples

NSolve(f(z),z,guess)
nSolve(f(z), z, guess) is a simple numerical solver which uses Halley's method (tangent hyperbolas method) to find the root of a given function or to solve a given equation.

f(z) is the function to be solved. If f(z) is not an equation then f(z)=0 is assumed. z is the independant variable guess is an initial start value f(z) can have real and complex arguments and the returned root can either be real or complex. nSolve only returns one root at a time.

If you need to solve pure polynomial equations, then Solve(f(z),z) and pSolve(f(z),z) are a better choice.

Examples

Eval(f(z),z,val)
Eval( function, var, value) replaces in a given function the variable var with value and returns the result of this calculation.

function can be a single function or a list of functions var can be a single variable or a list of variables value is a single variable when var is a single variable, a list otherwise.

Examples

PolyDivide(f(z),g(z))
PolyDivide(f(z), g(z)) returns both the quotient and remainder from the polynomial division of numerator f(z) and denominator g(z). Both numerator and denominator should be polynomial functions. The returned result is a list with the first term the quotient and the second term the remainder.

Examples

Quotient(f(z),g(z))
Quotient(f(z), g(z)) returns the quotient from the polynomial division of numerator f(z) and denominator g(z). Both numerator and denominator should be polynomial functions.

Examples

Remainder(f(z),g(z))
Remainder(f(z), g(z)) returns the remainder from the polynomial division of numerator f(z) and denominator g(z). Both numerator and denominator should be polynomial functions.

Examples

PolyFit(pList,var)
PolyFit(pList, [var]) finds a unique polynomial function of order N-1 through the given N data points.

pList are the datapoints given in a [N,2] matrix pList should be greater than 1 and less than 11. var is an optional variable for the returned polynomial. If not given, then var=x

Examples

Bernoulli(n,z)
Bernoulli(n,z) returns the nth Bernoulli polynomial of z. z can be either real or complex, n should be a positive integer.

Examples

Euler(n,z)
Euler(n,z) returns the nth Euler polynomial of z. z can be either real or complex, n should be a positive integer.

Examples

Fibonacci(n,z)
Fibonacci(n,z) returns the nth Fibonacci polynomial of z. z can be either real or complex, n should be a positive integer.

Examples

Lucas(n,z)
Lucas(n,z) returns the Lucas polynomial of z. z can be either real or complex, n should be a positive integer.

Examples

ChebyshevT(n,z)
ChebyshevT(n,z) returns the Chebyshev polynomial of the first kind. z can be either real or complex, n should be a positive integer.

Examples

ChebyshevU(n,z)
ChebyshevU(n,z) returns the Chebyshev polynomial of the second kind. z can be either real or complex, n should be a positive integer.

Examples

LegendreP(n,z)
LegendreP(n,z) returns the Legendre polynomial or Legendre function of the first kind.

n should be a positive integer z can be any number, real or complex

Examples

LegendreQ(n,z)
LegendreQ(n,z) returns the Legendre function of the second kind.

n should be a positive integer z can be any number, real or complex

LaguerreL(n,z)
LaguerreL(n,z) returns the Laguerre polynomial.

n should be a positive integer z can be any number, real or complex

HermiteH(n,z)
HermiteH(n,z) returns the Hermite polynomial.

n should be a positive integer z can be any number, real or complex

GegenbauerC(n,a,z)
GegenbauerC(n,a,z) returns the Gegenbauer polynomial.

n should be a positive integer z can be any number, real or complex

Sum(f(n),n,n1,n2)
Sum( f(n), n, start, end) is used to calculate the sum of f(n) where n goes from start to end.

Examples

Product(f(n),n,n1,n2)
Product( f(n), n, start, end) is used to calculate the product of f(n) where n goes from start to end.

Examples

Limit(f(x),x,x0,-1/0/+1)
Limit( function, variable, point, direction) returns the limit of function as variable approaches point from the direction direction.

The default value of direction is 0 (i.e. TwoSided Limit). Use +1 for a right sided limit Use -1 for a left sided limit

Examples

D(f(x),x)
D( function, variable) is equivalent to Diff( function , variable). Both functions find the first derivative of function to variable.

D(f,x) can be used on all common functions. Diff(f,x) can be used on both common and special functions.

Examples

D(f(x),x,n)
D(function, variable, n) finds the nth derivative of a function.

D(f,x,n) can only be used on all common functions.

Examples

Diff(f(x),x)
Diff( function, variable) is equivalent to D( function , variable). Both functions find the first derivative of a function to variable.

D(f,x) can be used on all common functions. Diff(f,x) can be used on both common and special functions.

Examples

FDiff(f(x,y,z,..),(x,y,z,...))
fDiff(function, variable list) finds the exact differential of the given function.

Examples

IDiff(f(x,y,z,..),(d vars),i var)


iDiff(function, dependant variable (list), independant variable (list) ) finds the implicit derivative of the given function. The dependant variable(s) are an unspecified function of the independant variable(s)

Examples

PDiff(f(x,y,z,..),(f vars),(f equ),i var)


pDiff( function, dependant var list , dependant var equation list, independant var ) finds the partial derivative of the function to indepedant var. The dependant vars are a given function of the independant var. This equation is given in the equation list.

Examples

Int(f(x),x)
int(function , variable) finds the indefinite integral of the given function.

Examples

Int(f(x),x,a,b)
int(function , variable, a, b) finds the definite integral of the given function. The limits of integration are a (lower limit) and b (upper) limit

Examples

NIntegrate(f(x),x,a,b)
nIntegrate(function , variable, a, b) finds the definite integral of the given function by a numerical integration method. The limits of integration are a (lower limit) and b (upper) limit

Examples

Series(f(z),z,n)
Series(function, variable, n) finds the serie expansion of a function around zero. This function is the same as the Maclaurin series. This function can be used on all common and most special functions.

Examples

FourierSin(f(x),x,w)
FourierSin(f(x),x,w) takes the Fourier Sine Transform of the given function. Current implementation is very limited.

Examples

FourierCos(f(x),x,w)
FourierCos(f(x),x,w) takes the Fourier Cosine Transform of the given function. Current implementation is very limited.

Examples

FourierSeries(f(x),x,n)
FourierSeries( function definition, variable, n) creates the Fourier series of a given function. The function definition should be given as an array : [ [f(t1), t1, t2] , [f(t2), t2, t3] , ...[f(tn), tn, tn+1] ] where

f(t1) is the function definition for t1 < t < t2 f(t2) is the function definition for t2 < t < t3 ......

Examples

Dot(A,B)
dot(A,B) calculates the dot product of 2 vectors : A and B Vectors A and B can be of any size, but should be equal to each other.

Examples

Cross(A,B)
cross(A,B) calculates the cross product of two 3-dimensional vectors : A and B

Examples

Norm(A)
Norm(A) returns the norm of the given vector A

Examples

Gradient(function,varlist)
Gradient(function,[varlist],[mode]) returns the Gradient of function(varlist) . This is normally denoted as : Grad(F) = F

The function can be defined in cartesian coordinates (mode=0), cylindrical coordinates (mode=1) or spherical coordinates (mode=2). Mode=0 is the default mode and being assumed when not given. When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes function is given as : o mode=0 : f(x, y, z) o mode=1 : f(r, , z) o mode=2 : f(r, , ) When other variables are used, then these have to be declared in the varlist as : [ var1 , var2 , var3 , ...]

Examples

Divergence(vector,varlist)
Divergence(vector,[varlist],[mode]) returns the divergence of a vector field . This is normally denoted as : Divergence(F) = .F

The vector field can be defined in cartesian coordinates (mode=0), cylindrical coordinates (mode=1) or spherical coordinates (mode=2). Mode=0 is the default mode and being assumed when not given. When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes the vector definition is given as a function of :
o o o

mode=0 : [x, y, z] mode=1 : [r, , z] mode=2 : [r, , ]

When other variables are used, then these have to be declared in the varlist as : [ var1 , var2 , var3 , ...]

Examples

Curl(vector,varlist)
Curl(vector,[varlist],[mode]) returns the curl of a vector field . This is normally denoted as : Curl(F) = x F

The vector field can be defined in cartesian coordinates (mode=0), cylindrical coordinates (mode=1) or spherical coordinates (mode=2). Mode=0 is the default mode and being assumed when not given. When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes the vector definition is given as a function of :
o o o

mode=0 : [x, y, z] mode=1 : [r, , z] mode=2 : [r, , ]

When other variables are used, then these have to be declared in the varlist as : [ var1 , var2 , var3 , ...]

Examples

Laplacian(function,varlist)
Laplacian(function,[varlist],[mode]) returns the Laplacian of function(varlist) . This is normally denoted as : Laplacian(F) = 2F

The function can be defined in cartesian coordinates (mode=0), cylindrical coordinates (mode=1) or spherical coordinates (mode=2). Mode=0 is the default mode and being assumed when not given. When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes function is given as : o mode=0 : f(x, y, z) o mode=1 : f(r, , z) o mode=2 : f(r, , ) When other variables are used, then these have to be declared in the varlist as : [ var1 , var2 , var3 ]

Examples

Jacobian(function,varlist,point)
Jacobian(function,[varlist],[point]) returns either the Jacobian matrix or the Jacobian determinant of a function list function(varlist) evaluated at point .

When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes all functions are f(x, y, z) When point is omitted, then the Jacobian matrix is returned. When point is given, then the matrix is evaluated at that point. If point is given and the number of equations = number of variables, then the Jacobian determinant is returned

Examples

Hessian(function,varlist)
Hessian(function, [varlist], [mode]) returns the Hessian matrix (mode=0) or Hessian determinant (mode=1) of a given function.

When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes function(x, y, z) When mode is omitted, then the function returns the Hessian matrix.

Examples

Duf(function,varlist,point,direction)
Duf(function, [varlist], [point], [direction]) calculates the directional derivative of a given function.

When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes function(x, y, z) If point is given, then the directional derivative is calculated at that point. If not, then [x, y, z] is used If additonally direction is given, then the derivative is calculated at the given point in the direction of the given vector. If no direction is given, then the vector [1, 1, 1] is assumed.

Examples

SurfaceNormal(function,varlist,point)
SurfaceNormal(function, [varlist], [point]) calculates the normal vector to the surface given by function at point.

When varlist is ommited or equal to "0", then SpaceTime 3.0 assumes function(x, y, z) If point is given, then the normal vector is calculated at the given point. If not, then [x, y, z] is used.

(Both the positive and negative normal vectors are returned)

Examples

Plot
The Plot function plots 2D functions, parametric, polar, implicit, and contour graphs. This function also lets you specify your graphing variable, graphing window, and type of 2D graph.

You can also plot graphs by clicking the Plot Button or by pressing Ctrl + Enter. Learn more about 2D Graphing.

Plot(equation)
This is the simplest way to use plot. These examples plot a single equation and the type of graph is auto detected by using the default 2D graphing variables.

Plot(equation, window, [type])


These examples let you specify your graphing variable, graphing window, and type of 2D graph. Equation Description: The parameter is the equation to graph. Example: sin(x) Window Description: This parameter is a list containing the graphing variable name and window values. Example: [x, -5, 5] Type Description: This parameter specifies the type of plot to graph. This will graph 2D functions by default if no parameter is specified. Example: function, parametric, polar, implicit, or contour

Plot(equation1, equation2, ...)


These examples plot a list of equations. The type of graph is auto detected by using the default 2D graphing variables. You can also input a list of equations using one parameter like this, Plot([equation1, equation2, ...]).

Plot(index1, index2, ...)


These examples plot a list of plots. This allows you to graph multiple types of 2D plots in the same graph. The index parameters represent the index number of each entry in the notebook. These numbers can be found on the index button on each entry. You can also use a list of numbers, Plot([2,4,12]), instead of multiple parameters to plot a list of plots.

Plot3D
The Plot3D function plots 3D functions, parametric, spherical, and cylindrical graphs. This function also lets you specify your graphing variable, graphing window, and type of 3D graph.

You can also plot graphs by clicking the Plot Button or by pressing Ctrl + Enter. Learn more about 3D Graphing.

Plot3D(equation)
This is the simplest way to use plot. These examples plot a single equation and the type of graph is auto detected by using the default 3D graphing variables.

This example graphs a 3D parametric plot followed by a 3d function plot.

This example uses multiple line input to graph a more complicated 3D parametric plot.

Plot3D(equation, window1, window2, [type])


These examples let you specify your graphing variable, graphing window, and type of 3D graph. Equation Description: The parameter is the equation to graph. Example: sin(x) Window1 Description: This parameter is a list containing the graphing variable name and window values. The last parameter points is optional. Example: [x, min, max, (points)] Window2 Description: This parameter is a list containing the graphing variable name and window values. The last parameter points is optional. Example: [y, min, max, (points)] Type Description: This parameter specifies the type of plot to graph. This will graph 3D functions by default if no parameter is specified. Example: function, parametric, spherical, or cylidrical

Plot3D(equation1, equation2, ...)


These examples plot a list of equations. The type of graph is auto detected by using the default 3D graphing variables. You can also input a list of equations using one parameter like this, Plot([equation1, equation2, ...]). Image:Plot79.png

Plot3D(index1, index2, ...)


These examples plot a list of plots. This allows you to graph multiple types of 3D plots in the same graph. The index parameters represent the index number of each entry in the notebook. These numbers can be found on the index button on each entry. You can also use a list of numbers, Plot([2,4,12]), instead of multiple parameters to plot a list of plots.

ListPlot
The ListPlot function plots 2D scatter plots, histograms, box plots, and normal probability plots.

ListPlot(list)

ListPlot(list, type)

type can be either scatter or histogram

ListPlot(list1, list2, ...)


list1 = x-values first group list2 = y-values first group list3 = x-values second group list4 = y-values second group ....

(the number of lists should always be a pair number)

BodePlot(function,var)
BodePlot(function,variable,minimum,maximum,mode) creates a Bode plot for the given function.

function : is the function to plot variable : is the independant variable minimum : start sweep frequency : min (rad/sec) maximum : end sweep frequency : max (rad/sec) mode = 0 : magnitude plot (= default mode) mode = 1 : phase plot in degrees mode = 2 : phase plot in radians

The x-axis is a logarithmic scale and represents the frequency in rad/sec


x = -2 : => = 0.01 rad/sec x = -1 : => = 0.1 rad/sec x = 0 : => = 1 rad/sec x = 1 : => = 10 rad/sec x = 2 : => = 100 rad/sec x = 3 : => = 1000 rad/sec ...

When the frequency is not given, then min = 0.01 rad/sec and max = 1000 rad/sec. The y-axis is either the magnitude in dB (mode=0) or the phase in degrees (mode=1) or the phase in radians (mode=2)

Examples

ImagePlot
The ImagePlot function plots an image from a matrix of real values.

ImagePlot(matrix)
This plots a grayscale image. The values in matrix are assumed to be from 0.0 to 1.0 where zero is black and one is white.

ImagePlot(r, g, b)
This plots a color image. The values in r, g, and b are assumed to be from 0.0 to 1.0 where zero is black and one is red, green, or blue.

Examples
This example creates a script using ImagePlot to output an image.

Clip(x,min,max)
clip(x , [min] , [max]) is used to clip 2D plot functions. Min and max are optional parameters and set to [-1,1] when not given.

Examples

SquareWave(x,T)
SquareWave(x,[T]) is a predefined 2D plot function. It creates a square wave of period = T (default= 2)

Examples

TriangleWave(x,T)
TriangleWave(x,[T]) is a predefine 2D plotfunction which creates a triangle wave. T is the period and equals 2 when not given.

Examples

SawToothWave(x,T)
SawToothWave(x,[T]) creates a predefined 2D sawtooth wave with period = T (default = 2)

Examples

StaircaseWave(x,T)
StairCaseWave(x,[T]) creates a predefined 2D staircase wave with period = T (default = 2)

Examples

FullRectSineWave(x,T)
FullRectSineWave(x,[T]) creates a predefined 2D full rectified sine wave with period = T (default = 2)

Examples

HalfRectSineWave(x,T)
HalfRectSineWave(x,[T]) creates a predefined 2D half rectified sine wave with period = T (default = 2)

Examples

Gamma(z)
Calculates Gamma(z) where z can be any complex number.

Examples

Gamma(a,z) = Incomplete Gamma


Calculates the InComplete Gamma function : Gamma(a,z), where both a and z can be a real or a complex number.

Examples

DiGamma(z) or Psi(z)
Calculates the DiGamma(z) or Psi(z) where z can be any complex number.

Examples

Beta(m,n)
Beta(m,n) calculates the Beta function of m,n both real or complex variables.

Examples

Zeta(z) = Riemann Zeta


Zeta(z) finds the Riemann Zeta of a given real or complex number.

Examples

Zeta(z,a) = Hurwitz Zeta


Zeta(z,a) finds the Hurwitz Zeta function, z can be any real or complex number and a is limited to some real numbers. Zeta(z,a) is the same as Zeta(0,z,a). Higher order differentials of Zeta are currently not implemented.

Examples

Harmonic(z)
Harmonic(z) calculates the Harmonic Number of z, with z being a real or complex number.

Examples

Si(z), Ci(z)
Si(z) is the Sine Integral of z Ci(z) is the Cosine Integral of z In above, z can be a real or complex number

Examples

Ei(z), Li(z)
Ei(z) finds the Exponential Integral of z, with z being a real or complex number Li(x) finds the Logarithmic Integral of x, with x being a real number.

Examples

Shi(z), Chi(z)
Shi(z) is the Hyperbolic Sine Integral of z Chi(z) is the Hyperbolic Cosine Integral of z In above, z can be a real or complex number

Examples

FrenselSin(z)
FresnelSin(z) returns the Fresnel Sine Integral of z. z can be a real or complex number.

Examples

FresnelCos(z)
FresnelCos(z) returns the Fresnel Cosine Integral of z. z can be a real or complex number.

Examples

Erf(z)
Erf(z) returns the Error Function of z. z can be real or complex

Examples

Erfc(z)
Erfc(z) returns the Complementary Error Function of z. z can be real or complex.

Examples

BesselJ(v,z)
BesselJ(v,z) returns the Bessel function of the first kind. v can be any Real number, z can be either real or complex.

Examples

BesselY(v,z)
BesselY(v,z) returns the Bessel function of the second kind. v can be any Real number, z can be either real or complex.

Examples

BesselI(v,z)
BesselI(v,z) returns the Modified Bessel function of the first kind. v should be a real number, z can be either real or complex.

Examples

BesselK(v,z)
BesselK(v,z) returns the Modified Bessel function of the second kind. v must be a real number, z can be either real or complex.

Examples

KelvinBer(v,z)
Calculates KelvinBer(v,z) where v is a real number and z can be real or complex.

Examples

KelvinBei(v,z)
Calculates KelvinBei(v,z) where v is a real number and z can be real or complex.

Examples

KelvinKer(v,z)
Calculates KelvinKer(v,z) where v is a real number and z can be real or complex.

Examples

KelvinKei(v,z)
Calculates KelvinKei(v,z) where v is a real number and z can be real or complex.

Examples

HankelH1(v,z)
HankelH1(v,z) calculates the Hankel function of the first kind. v should be a real number and z can be either real or complex

Examples

HankelH2(v,z)
HankelH2(v,z) calculates the Hankel function of the second kind. v should be a real number and z can be either real or complex

Examples

AiryAi(z) - AiryBi(z)
AiryAi(z) returns the Airy function Ai(z) AiryBi(z) returns the Airy function Bi(z) z can either be a real or a complex value

Examples

Graphs

Gudermannian(z)
Gudermannian(z) returns the Gudermannian function of z. This function can only be used with numerical, either real or complex, values.

Examples

InvGudermannian(z)
invGudermannian(z) returns the inverse Gudermannian function of z. This function can only be used with numerical, either real or complex, values.

Examples

Identity(n)
Identity(n) returns the n x n identity matrix

n should be a positive integer.

Examples

Inverse(A)
Inverse(A) calculates the inverse of a given square matrix A

Examples

Transpose(A)
Transpose(A) calculates the transpose of a matrix A

Examples

Det(A)
Det(A) finds the determinant of the given matrix A

matrix A should be a square matrix

Examples

RowReduce(A)
RowReduce(A) performs a Gaussian elimination on the given matrix A

Examples

Eigenvalues(A)
Eigenvalues(A) returns the eigenvalues of matrix A

Examples

QR(A)
QR(A) returns the QR factorization or QR decomposition of matrix A

The first element returned is the orthogonal matrix (usually denoted as Q) The second element returned is the upper triangular matrix (R)

Examples

SVD(A)
SVD(A) returns a list with singular values of a matrix A

Examples

Cholesky(A)
Cholesky(A) returns a list with singular values of a positive definite matrix A

Examples

Min(List)
Min(list) finds the smallest number in a given list.

Examples

Max(List)
Max(list) finds the largest number in a given list.

Mean(List)
Mean(list) finds the average of a given list of numbers. List can be an one dimensional or a multi dimensional list.

Variance(List)
Variance(list) finds the variance of a given list of numbers. List can be an one dimensional or a multi dimensional list.

StandardDeviation(List)
StandardDeviation(list) finds the standard deviation of a given list of numbers. List can be an one dimensional or a multi dimensional list.

Binomial
BinomialPDF(n, p, x) computes the binomial distribution at x with number of trials n and probability of success p on each trial. BinomialCDF(n, p, x) computes the cumulative Binomial distribution at x with number of trials n and probability of success p on each trial.

n - Positive Integer p - real number between 0 and 1 x - integer or list of integers

ChiSquare
ChiSquarePDF(x, df) computes the ChiSquare distributions probability density function at the value x with degrees of freedom df. ChiSquareCDF(lower, upper, df) computes the ChiSquare distribution cumulative density function over the interval defined by lower and upper with degrees of freedom df.

x - nonnegative real number df - positive real number lower - nonnegative real number upper - nonnegative real number

Geo
GeoPDF(p, x) computes the geometric distribution at x with probability of success p. GeoCDF(p, x) computes the cumulative geometric distribution at x with probability of success p.

p - Real number between 0 and 1 x - Integer or list of integers

Normal
NormalPDF() computes either the normal probability density function at x with mean mu and standard deviation sigma. The default values are mu = 0 and sigma = 1. NormalCDF() computes the normal cumulative density function over the interval from lower to upper with mean mu and standard deviation sigma. The default values are mu = 0 and sigma = 1. Use these functions as :

NormalPDF(x) NormalPDF(x,mu) NormalPDF(x,mu,sigma) NormalCDF(lower,upper) NormalCDF(lower,upper,mu,sigma)

Parameters :

x - real number mu - real number sigma - positive real number lower - real number upper - real number

Student
StudentTPDF(x, df) computes the Student-t probability density function at a value x with degrees of freedom df. StudentTCDF(lower, upper, df) computes the Student-t cumulative density function over the interval defined by lower and upper with degrees of freedom df.

x - nonnegative real number df - positive real number lower - nonnegative real number upper - nonnegative real number

Poisson
PoissonPDF(mu, x) computes the Poisson distribution at x with mean mu. PoissonCDF(mu, x) computes the cumulative Poisson distribution at x with mean mu.

mu - Positive real number x - Integer or list of integers

InverseNormal
InverseNormal(p) computes the x value to a corresponding area p using the inverse cumulative normal distribution function.

p - Real number between 0 and 1

Constant
The constant(name) function returns fundamental physical constants as a real number.

These constants can be assigned to any variable for further usage in your formula. The value of the constant is given in SI-units

Example

Table
One Variable
Table(function, [independent, start, end, step], dependent)

Clear(variable)
This function is used to clear all variables.

Examples

Append(a,b)
The command Append(a,b) is used to concatenate a and b a and b can be a value, a variable, a string, a list or a matrix

Examples

Part(expression, index)
This command finds the function with highest priority. Index indicates which part you are searching for in expression. It should be used as :

Part(expression, 0) to find the function name Part(expression, 1) to find the left side to the function Part(expression, 2) to find the first right side to the expression Part(expression, 3) finds further right parts, if there are any.

If there is no right side, then Part(expression, 2) returns "0"

Examples

Size(list)
Size(list) returns the size of a list or a matrix.

Examples

Choose
Choose creates a a piecewise-defined function.

Choose(test1, value1, test2, value2, ...)

Variables(expression)
Variables returns a list variables found in the expression.

Examples

Call(function,Parameters)
Call(function name, parameter1, parameter2, ...) executes a call to the given function and passes the included parameters to that function. The given function is then executed.

Examples

Function(function,Parameters)
Function(function,Parameters) returns the given function together with it's parameters back UNEVALUATED

Examples

You might also like