D, Eliminate, Expand, Factor, Integrate, Plus, Power, Refine, Times,...See: Description
| Class | Description |
|---|---|
| Abs |
Absolute value of a number.
|
| AddTo |
Operator +=
|
| Apart |
Evaluate the partial fraction decomposition of a univariate polynomial
fraction.
|
| ArcCos |
Arccosine
See Inverse_trigonometric functions
|
| ArcCosh |
Inverse hyperbolic cosine
See
Inverse
hyperbolic functions
|
| ArcCot |
Arccotangent
See Inverse_trigonometric functions
|
| ArcCoth |
Arccotangent hyperbolic
See
Inverse
hyperbolic functions
|
| ArcCsc |
Inverse hyperbolic tangent
See
Inverse
hyperbolic functions
|
| ArcCsch |
Inverse hyperbolic tangent
See
Inverse
hyperbolic functions
|
| ArcSec |
Inverse hyperbolic tangent
See
Inverse
hyperbolic functions
|
| ArcSech |
Inverse hyperbolic secant
See
Inverse
hyperbolic functions
|
| ArcSin |
Arcsine
See Inverse_trigonometric functions
|
| ArcSinh |
Arcsin hyperbolic
See
Inverse
hyperbolic functions
|
| ArcTan |
Arctangent
See Inverse_trigonometric functions
|
| ArcTanh |
Inverse hyperbolic tangent
See
Inverse
hyperbolic functions
|
| Arg | |
| ArrayDepth | |
| BernoulliB |
Compute the Bernoulli number of the first kind.
|
| BesselJ |
Bessel function of the first kind.
|
| Binomial |
Returns the binomial coefficient of 2 integers.
|
| Boole |
Predicate function
Returns
1 if the 1st argument evaluates to True; returns 0 if the 1st argument evaluates
to False; and null otherwise. |
| BooleanConvert | |
| BooleanMinimize |
Minimize a boolean function with the Quine
McCluskey algorithm.
|
| Cancel |
Cancel(expr) - cancels out common factors in numerators and denominators.
|
| CartesianProduct |
Cartesian product for multiple lists.
|
| CatalanNumber | |
| Ceiling |
Returns the smallest (closest to negative infinity)
ISignedNumber value that is not less than this and
is equal to a mathematical integer. |
| CharacteristicPolynomial |
Compute the characteristic polynomial of a matrix.
|
| ChebyshevT | |
| ChebyshevU | |
| ChessboardDistance |
ChessboardDistance of two vectors
|
| Coefficient | |
| CoefficientList | |
| CoefficientRules |
Get exponent vectors and coefficients of monomials of a polynomial
expression.
|
| Complement | |
| ComplexExpand |
Exponential definitions for trigonometric functions
See
Wikipedia - List of trigonometric identities
|
| ComposeList | |
| Conjugate |
Conjugate the given argument.
|
| ConjugateTranspose |
Conjugate and transpose a matrix.
|
| ConstantArray |
Array structure generator for constant (i,j) value.
|
| ConstantArray.ArrayIterator | |
| ContinuedFraction |
ContinuedFraction of a double or fraction number
See: Continued
fraction
|
| CoprimeQ |
The integers a and b are said to be coprime or relatively prime if they have no common factor other than 1.
|
| Cos |
Cosine function
See
Trigonometric
functions and
Wikipedia - Exact trigonometric constants
|
| Cosh |
Hyperbolic cosine
See Hyperbolic
function
|
| CosIntegral | |
| Cot |
Cotangent function
See
Trigonometric
functions
|
| Coth |
Hyperbolic cotangent
See Hyperbolic
function
|
| Cross |
Calculate the cross product of 2 vectors with dimension 3.
|
| Csc |
Cosecant function
See
Trigonometric
functions
|
| Csch |
Hyperbolic Cosecant function
See Hyperbolic
functions
|
| Curl |
See: Wikipedia:Curl (mathematics)
Example:
Curl[{f[u,v,w],f[v,w,u],f[w,u,v],f[x]}, {u,v,w}]. |
| D |
Differentiation of a function.
|
| Decrement | |
| Default |
Get the default value for a symbol (i.e.
|
| DeleteDuplicates |
Delete duplicate values from a list.
|
| Denominator |
Get the denominator part of an expression
See Wikipedia:
Fraction (mathematics)
|
| Derivative |
Determine the derivative of a given function symbol.
|
| Det |
Compute the determinant of a matrix
See Determinant
|
| DiagonalMatrix |
Create a diagonal matrix from a list
|
| DigitQ |
Returns
True, if the given expression is a string which only
contains digits. |
| Dimensions |
Get the dimensions of an expression
|
| Discriminant | |
| Distribute | |
| Divergence |
See Wikipedia - Divergence
Example:
Divergence[{f[u,v,w],f[v,w,u],f[w,u,v]}, {u,v,w}]. |
| DivideBy |
Operator /=
|
| Divisible | |
| Divisors |
Return the divisors of an integer number.
|
| Dot | |
| DSolve | |
| Eigenvalues |
Compute the numerical Eigenvalues of a real symmetric matrix
See: Wikipedia - Eigenvalue, eigenvector and
eigenspace
|
| Eigenvectors |
Compute the numerical Eigenvectors of a real symmetric matrix
See: Eigenvalue, eigenvector and eigenspace
|
| Eliminate |
Try to eliminate a variable in a set of equations (i.e.
|
| Equal |
== operator implementation. |
| Equivalent | |
| Erf |
Returns the error function.
|
| EuclidianDistance |
EuclidianDistance of two vectors
|
| EulerE |
Euler number
|
| EulerPhi |
Euler phi function
See: Euler's totient function
|
| Exp | |
| Expand | |
| ExpandAll | |
| ExtendedGCD |
Returns the gcd of two positive numbers plus the bezout relations
See Extended Euclidean algorithm and See Bézout's identity
|
| Extract | |
| Factor |
Factor a univariate polynomial
|
| Factorial |
Returns the factorial of an integer n
See Factorial
|
| Factorial2 | |
| FactorInteger |
Return the factors of an integer number
FactorInteger[-32536] ==> {{-1,1},{2,3},{7,2},{83,1}}
|
| FactorSquareFree |
Factors out only multiple factors of a univariate polynomial
|
| FactorSquareFreeList |
Factors out only multiple factors of a univariate polynomial
|
| FactorTerms | |
| Fibonacci | |
| FindRoot |
Function for
numerically
finding roots of a univariate real function.
|
| Fit |
Polynomial fitting of a given data point set.
|
| Floor |
Returns the largest (closest to positive infinity)
ISignedNumber value that is not greater than this
and is equal to a mathematical integer. |
| FractionalPart |
Get the fractional part auf a number
|
| FresnelC | |
| FresnelS | |
| FrobeniusSolve | |
| FromCharacterCode | |
| FromContinuedFraction |
Convert a list of numbers to a fraction.
|
| FullSimplify |
Try to simplify a given expression
|
| Gamma |
Returns the Gamma function value.
|
| Gather | |
| GCD |
Greatest common divisor
See Wikipedia:
Greatest common divisor
|
| GeometricMean | |
| Greater |
> operator implementation. |
| GreaterEqual |
>= operator implementation. |
| GroebnerBasis |
Compute the Groebner basis for a list of polynomials.
|
| HarmonicNumber |
Harmonic number of a given integer value
See: Harmonic number
|
| Haversine | |
| HermiteH | |
| HilbertMatrix |
Hilbert matrix, defined by Ai,j = 1 / (i+j-1).
|
| HilbertMatrix.HilbertFunctionDiagonal | |
| Horner | Deprecated
use HornerForm
|
| HornerForm |
Generate the horner scheme for univariate polynomials.
|
| IdentityMatrix |
Create an identity matrix
See Wikipedia -
Identity matrix
|
| Im |
Get the imaginary part of an expression
See: Imaginary part
|
| Increment | |
| Inner | |
| IntegerExponent |
IntegerExponent(n, base) gets the highest exponent of base (greater than 1)
that divides n.
|
| IntegerPart | |
| IntegerPartitions |
Generate all integer partitions for a given integer number.
|
| IntegerPartitions.NumberPartitionsIterable |
Returns all partitions of a given int number (i.e.
|
| Integrate |
Integration of a function.
|
| InterpolatingFunction | |
| InterpolatingPolynomial |
Newton polynomial interpolation , is the interpolation polynomial for a given set of data points in the Newton form.
|
| Intersection |
Intersection of 2 sets
See:
Intersection
(set theory)
|
| Inverse |
Invert a matrix
See Invertible
matrix
|
| InverseErf |
Returns the inverse erf.
|
| InverseFunction | |
| InverseHaversine | |
| JacobiMatrix |
Create a Jacobian matrix.
|
| JacobiSymbol | |
| Join | |
| KOrderlessPartitions | |
| KPartitions |
Generate a list of all all k-partitions for a given list with N elements.
|
| KPartitions.KPartitionsIterable |
This class returns the indexes for partitioning a list of N elements.
|
| KPartitions.KPartitionsList |
This
Iterable iterates through all k-partition lists for a given list with N elements. |
| LaguerreL | |
| LaplaceTransform | |
| LCM |
Least common multiple
See
Wikipedia:Least
common multiple
|
| LegendreP | |
| Less |
< operator implementation. |
| LessEqual |
<= operator implementation. |
| LetterQ |
Returns
True, if the given expression is a string which only
contains letters |
| Level | |
| Limit |
Limit of a function.
|
| LinearProgramming |
The LinearProgramming provides an implementation of George Dantzig's
simplex algorithm for solving linear optimization problems with linear equality and inequality constraints.
|
| LinearSolve |
Determine
x for Matrix A in the equation A.x==b |
| Log | |
| Log10 | |
| Log2 | |
| LowerCaseQ |
Returns
True, if the given expression is a string which only
contains lower case characters |
| LUDecomposition | |
| ManhattanDistance |
The Manhattan distance of two vectors.
|
| Map | |
| MapAll | |
| MapAt | |
| MapThread | |
| MatrixPower | |
| MatrixQ |
Predicate function
Returns
True if the 1st argument is a matrix; False
otherwise |
| MatrixRank |
Compute the rank of a matrix.
|
| Max | |
| Mean |
See Arithmetic mean
|
| Median |
See Median
|
| Min | |
| Mod | |
| MoebiusMu |
The Möbius function.
|
| MonomialList |
Get the list of monomials of a polynomial expression.
|
| Most | |
| Multinomial |
Returns the multinomial coefficient.
|
| Names | |
| Negative | |
| NextPrime |
Get the next prime number.
|
| NFourierTransform | |
| NIntegrate |
Function for numerical integration of univariate real functions.
|
| NMaximize | |
| NMinimize | |
| NonCommutativeMultiply | |
| NonNegative | |
| Norm |
Norm of a given argument
|
| Normalize |
Normalize[vector] calculates the normalized vector. |
| Not | |
| NRoots |
Determine the numerical roots of a univariate polynomial
See Wikipedia entries for:
Quadratic
equation , Cubic
function and
Quartic function
|
| NSolve |
Try to solve a set of equations (i.e.
|
| NullSpace |
Compute the null space of a matrix.
|
| Numerator |
Get the numerator part of an expression
See Wikipedia:
Fraction (mathematics)
|
| Order |
Compares the first expression with the second expression for order.
|
| OrderedQ | |
| Out |
Get the specified history line fro the
EvalEngine's history list. |
| Outer | |
| PadLeft | |
| PadRight | |
| Partition | |
| Permutations |
Generate a list of permutations
See Permutation
|
| Permutations.KPermutationsIterable |
Generate an Iterable for permutations
See Permutation
|
| Permutations.KPermutationsList |
Generate a list of permutations
See Permutation
|
| Piecewise |
A piecewise-defined function (also called a piecewise function or a hybrid function) is a function which is defined by multiple
subfunctions, each subfunction applying to a certain interval of the main function's domain.
|
| Plot |
Plots x/y functions
|
| Plot3D |
Represents the Plot3D function
|
| Plus | |
| Pochhammer |
Compute Pochhammer's symbol (this)_n.
|
| PolynomialExtendedGCD |
Greatest common divisor of two polynomials.
|
| PolynomialGCD |
Greatest common divisor of two polynomials.
|
| PolynomialLCM |
Least common multiple of two polynomials.
|
| PolynomialQ |
Returns
True, if the given expression is a polynoomial object |
| PolynomialQuotient | |
| PolynomialQuotientRemainder | |
| PolynomialRemainder | |
| Positive | |
| PossibleZeroQ |
Predicate function
Returns
True if the 1st argument is 0;
False otherwise |
| Power | |
| PowerExpand |
Expand the powers of a given expression.
|
| PowerMod | |
| PreDecrement | |
| PreIncrement | |
| Prime |
Prime(i) gives the i-th prime number for i less
equal 103000000. |
| PrimeQ |
Test if a number is prime.
|
| PrimitiveRoots | |
| Product |
Product of expressions.
|
| ProductLog |
Lambert W function
See: Wikipedia - Lambert W function
|
| PseudoInverse |
Pseudoinverse of a matrix
See
Moore-Penrose pseudoinverse
|
| Quotient | |
| RandomInteger | |
| RandomReal | |
| RandomSample |
Create a random shuffled list.
|
| Range | |
| Rationalize | |
| Re |
Get the real part of an expression
See: Real part
|
| Replace | |
| ReplaceAll | |
| ReplaceList | |
| ReplacePart | |
| ReplaceRepeated | |
| Resultant | |
| Reverse | |
| RootIntervals |
Determine complex root intervals of a univariate polynomial
|
| Roots |
Determine the roots of a univariate polynomial
See Wikipedia entries for:
Quadratic
equation , Cubic
function and
Quartic function
|
| Round |
Round a given value to nearest integer.
|
| RowReduce |
Reduce the matrix to row reduced echelon form.
|
| SameQ |
=== operator implementation. |
| Scan | |
| Sec |
Secant function
See
Trigonometric
functions
|
| Sech |
Hyperbolic Secant function
See Hyperbolic
functions
|
| Select | |
| Sign |
Gets the sign value of a number.
|
| SignCmp |
Gets the signum value of a complex number
|
| Simplify |
Try to simplify a given expression
|
| Simplify.IsBasicExpressionVisitor | |
| Sin |
Sine function.
|
| Sinc |
Sinc function.
|
| SingularValueDecomposition | |
| Sinh |
Hyperbolic sine
See Hyperbolic
function
|
| SinIntegral | |
| Solve |
Try to solve a set of equations (i.e.
|
| Sort | |
| Sqrt | |
| SquaredEuclidianDistance |
SquaredEuclidianDistance of two vectors
|
| SquareFreeQ |
Check if a univariate polynomial is square free
|
| StirlingS2 |
Stirling numbers of the second kind.
|
| StringDrop | |
| StringJoin | |
| StringLength | |
| StringTake | |
| Subfactorial |
Returns the subfactorial of a positive integer n
See Wikipedia -
Derangement
|
| Subsets |
Generate a list of all k-combinations from a given list
See Combination
|
| Subsets.KSubsetsIterable |
Iterable for all k-combinations from a set
See Combination
|
| Subsets.KSubsetsList |
Iterate over the lists of all k-combinations from a given list
See Combination
|
| SubtractFrom |
Operator -=
|
| Sum |
Summation of expressions.
|
| Surd | |
| SyntaxLength | |
| SyntaxQ |
Returns
True, if the given expression is a string which has the
correct syntax |
| Table |
Table structure generator (i.e. lists, vectors, matrices, tensors)
|
| Tan |
Tan
See
Trigonometric
functions
|
| Tanh |
Hyperbolic tangent
See Hyperbolic
function
|
| Taylor |
Power series expansion with Taylor formula
|
| Thread | |
| Through | |
| Times | |
| TimesBy |
Operator *=
|
| ToCharacterCode | |
| Together |
Determine a common denominator for the expressions of a sum.
|
| ToString | |
| Total |
Sums up all elements of a list.
|
| ToUnicode | |
| Tr |
Trace of a matrix.
|
| Transpose |
Transpose a matrix.
|
| TrigExpand |
Expands the argument of sine and cosine functions.
|
| TrigReduce |
Transform products of trigonometric functions into "linear form".
|
| TrigToExp |
Exponential definitions for trigonometric functions
See
List of trigonometric identities - Exponential definitions,
Hyperbolic function |
| TrueQ |
Predicate function
Returns
True if the 1st argument evaluates to True; False otherwise |
| Tuples | |
| Unequal |
! |
| Union |
Union of two sets.
|
| UnitStep | |
| UnitVector |
Create a unit vector
See Wikipedia - Unit vector
|
| UnsameQ |
=! |
| UpperCaseQ |
Returns
True, if the given expression is a string which only
contains upper case characters |
| VandermondeMatrix |
Vandermonde matrix, defined by Ai,j = vector[i]^(j-1).
|
| Variables |
Determine the variable symbols of an expression
|
| VectorAngle |
VectorAngle(arg1, arg2) calculates the angle between vectors arg1 and arg2.
|
| VectorQ |
Predicate function
Returns
True if the 1st argument is a vector;
False otherwise |
| Xor |
Implementations of functions like D, Eliminate, Expand, Factor, Integrate, Plus, Power, Refine, Times,... .