Class F
- java.lang.Object
-
- org.matheclipse.core.expression.S
-
- org.matheclipse.core.expression.F
-
-
Field Summary
Fields Modifier and Type Field Description static IPattern
a_
Used to represent a formal patterna_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
A_
static IPattern
a_DEFAULT
static IPattern
A_DEFAULT
static IPattern
a_Symbol
static IPattern
b_
Used to represent a formal patternb_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
B_
static IPattern
b_DEFAULT
static IPattern
B_DEFAULT
static IPattern
b_Symbol
static IPattern
c_
Used to represent a formal patternc_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
C_
static IPattern
c_DEFAULT
static IPattern
C_DEFAULT
static IPattern
c_Symbol
static IInteger
C0
Constant integer "0"static IInteger
C1
Constant integer "1"static IInteger
C10
Constant integer "10"static IInteger
C100
Constant integer "100"static IInteger
C1000
Constant integer "1000"static IFraction
C1D2
Constant fraction "1/2"static IFraction
C1D3
Constant fraction "1/3"static IFraction
C1D4
Constant fraction "1/4"static IFraction
C1D5
Constant fraction "1/5"static IFraction
C1D6
Constant fraction "1/6"static IAST
C1DSqrt10
Represents1/Sqrt(10)
static IAST
C1DSqrt2
Represents1/Sqrt(2)
static IAST
C1DSqrt3
Represents1/Sqrt(3)
static IAST
C1DSqrt5
Represents1/Sqrt(5)
static IAST
C1DSqrt6
Represents1/Sqrt(6)
static IAST
C1DSqrt7
Represents1/Sqrt(7)
static IInteger
C2
Constant integer "2"static IFraction
C2D3
Constant fraction "2/3"static IAST
C2Pi
Represents2*Pi
as Symja expressionTimes(C2, Pi)
static IInteger
C3
Constant integer "3"static IFraction
C3D2
Constant fraction "3/2"static IFraction
C3D4
Constant fraction "3/4"static IInteger
C4
Constant integer "4"static IInteger
C5
Constant integer "5"static IFraction
C5D2
Constant fraction "5/2"static IInteger
C6
Constant integer "6"static IInteger
C7
Constant integer "7"static IInteger
C8
Constant integer "8"static IInteger
C9
Constant integer "9"static IAST
CComplexInfinity
RepresentsComplexInfinity
(i.e.static Num
CD0
Constant double "0.0"static Num
CD1
Constant double "1.0"static IComplexNum
CDI
Complex numerical imaginary unit.static IComplexNum
CDNI
Complex negative numerical imaginary unit.static IAST
CEmptyInterval
RepresentsInterval()
(i.e.static IAST
CEmptyIntervalData
RepresentsInterval()
(i.e.static IAST
CEmptyList
RepresentsList()
(i.e.static IAST
CEmptySequence
RepresentsSequence()
(i.e.static IStringX
CEmptyString
Represents the empty Smyja string""
static IComplex
CI
Complex imaginary unit "0 + I".static IAST
CIInfinity
RepresentsI*Infinity
(i.e.static IAST
CInfinity
RepresentsInfinity
(i.e.static IAST
CListC0
RepresentsList(0)
static IAST
CListC0C0
RepresentsList(0,0)
static IAST
CListC1
RepresentsList(1)
static IAST
CListC1C1
RepresentsList(1,1)
static IAST
CListC1C2
RepresentsList(1,2)
static IAST
CListC2
RepresentsList(2)
static IAST
CListC2C1
RepresentsList(2,1)
static IAST
CListC2C2
RepresentsList(2,2)
static IAST
CListCN1
RepresentsList(-1)
.static IAST
CMissingNotFound
RepresentsMissing("NotFound")
static IInteger
CN1
Constant integer "-1"static IInteger
CN10
Constant integer "-10"static IFraction
CN1D2
Constant fraction "-1/2"static IFraction
CN1D3
Constant fraction "-1/3"static IFraction
CN1D4
Constant fraction "-1/4"static IFraction
CN1D5
Constant fraction "-1/5"static IFraction
CN1D6
Constant fraction "-1/6"static IInteger
CN2
Constant integer "-2"static IFraction
CN2D3
Constant fraction "-2/3"static IAST
CN2Pi
Represents-2*Pi
as Symja expressionTimes(CN2, Pi)
static IInteger
CN3
Constant integer "-3"static IFraction
CN3D2
Constant fraction "-3/2"static IInteger
CN4
Constant integer "-4"static IInteger
CN5
Constant integer "-5"static IInteger
CN6
Constant integer "-6"static IInteger
CN7
Constant integer "-7"static IInteger
CN8
Constant integer "-8"static IInteger
CN9
Constant integer "-9"static Num
CND1
Constant double "-1.0"static IComplex
CNI
Complex negative imaginary unit "0 - I".static IAST
CNIInfinity
Represents-I*Infinity
(i.e.static IAST
CNInfinity
Represents-Infinity
(i.e.static IAST
CNPi
Represents-Pi
as Symja expressionTimes(CN1, Pi)
static IAST
CNPiHalf
Represents-Pi/2
as Symja expressionTimes(CN1D2, Pi)
static IAST
CNPiQuarter
Represents-Pi/4
as Symja expressionTimes(CN1D4, Pi)
static IAST
CNPiThird
Represents-Pi/3
as Symja expressionTimes(CN1D3, Pi)
static IAST
CPiHalf
RepresentsPi/2
as Symja expressionTimes(C1D2, Pi)
static IAST
CPiQuarter
RepresentsPi/4
as Symja expressionTimes(C1D4, Pi)
static IAST
CPiThird
RepresentsPi/3
as Symja expressionTimes(C1D3, Pi)
static IAST
CReturnFalse
RepresentsReturn(False)
static IAST
CReturnTrue
RepresentsReturn(True)
static IAST
CSqrt10
RepresentsSqrt(10)
static IAST
CSqrt2
RepresentsSqrt(2)
static IAST
CSqrt3
RepresentsSqrt(3)
static IAST
CSqrt5
RepresentsSqrt(5)
static IAST
CSqrt6
RepresentsSqrt(6)
static IAST
CSqrt7
RepresentsSqrt(7)
static IAST
CSqrtPi
RepresentsSqrt(Pi)
static IAST
CThrowFalse
RepresentsThrow(False)
static IAST
CThrowTrue
RepresentsThrow(True)
static IPattern
d_
Used to represent a formal patternd_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
d_DEFAULT
static IPattern
d_Symbol
static List<ISymbol>
DENOMINATOR_NUMERATOR_SYMBOLS
static List<IExpr>
DENOMINATOR_TRIG_TRUE_EXPRS
static IPattern
e_
Used to represent a formal patterne_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
e_DEFAULT
static IPattern
e_Symbol
static org.hipparchus.Field<IExpr>
EXPR_FIELD
static IPattern
f_
Used to represent a formal patternf_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
F_
static IPattern
f_DEFAULT
static IPattern
F_DEFAULT
static IPattern
f_Symbol
static IPattern
g_
Used to represent a formal patterng_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
G_
static IPattern
g_DEFAULT
static IPattern
G_DEFAULT
static IPattern
g_Symbol
static IPattern
h_
Used to represent a formal patternh_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
h_DEFAULT
static IPattern
h_Symbol
static IPattern
i_
Used to represent a formal patterni_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
i_DEFAULT
static IPattern
i_Symbol
static AbstractAST.NILPointer
INVALID
static IPattern
j_
Used to represent a formal patternj_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
j_DEFAULT
static IPattern
j_Symbol
static IPattern
k_
Used to represent a formal patternk_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
k_DEFAULT
static IPattern
k_Symbol
static IPattern
l_
Used to represent a formal patternl_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
l_DEFAULT
static IPattern
l_Symbol
static IPattern
m_
Used to represent a formal patternm_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
m_DEFAULT
static IPattern
m_Integer
static IPattern
m_Symbol
static IPattern
n_
Used to represent a formal patternn_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
n_DEFAULT
static IPattern
n_Integer
static IPattern
n_Symbol
static AbstractAST.NILPointer
NIL
The constant objectNIL
(not in list) indicates in the evaluation process that no evaluation was possible (i.e.static IAST
Noo
Alias for CNInfinity.static List<ISymbol>
NUMERATOR_NUMERATOR_SYMBOLS
static List<IExpr>
NUMERATOR_TRIG_TRUE_EXPRS
static IPattern
o_
Used to represent a formal patterno_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
o_DEFAULT
static IPattern
o_Symbol
static IAST
oo
Alias for CInfinity.static IPattern
p_
Used to represent a formal patternp_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
P_
static IPattern
p_DEFAULT
static IPattern
P_DEFAULT
static IPattern
p_Symbol
static Map<String,String>
PREDEFINED_INTERNAL_FORM_STRINGS
The map for predefined strings for theIExpr.internalFormString(boolean, int)
method.static IPattern
q_
Used to represent a formal patternq_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
Q_
static IPattern
q_DEFAULT
static IPattern
Q_DEFAULT
static IPattern
q_Symbol
static IPattern
r_
Used to represent a formal patternr_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
r_DEFAULT
static IPattern
r_Symbol
static com.google.common.cache.Cache<IAST,IExpr>
REMEMBER_INTEGER_CACHE
In computing, memoization or memoisation is an optimization technique used primarily to speed up computer programs by storing the results of expensive function calls and returning the cached result when the same inputs occur again.static IPattern
s_
Used to represent a formal patterns_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
s_DEFAULT
static IPattern
s_Symbol
static IAST
Slot1
Represents#1
, the first argument of a pure function.static IAST
Slot2
Represents#2
, the second argument of a pure function.static IAST
Slot3
Represents#3
, the third argument of a pure function.static ISymbolObserver
SYMBOL_OBSERVER
static IPattern
t_
Used to represent a formal patternt_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
t_DEFAULT
static IPattern
t_Symbol
static IPattern
u_
Used to represent a formal patternu_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
u_DEFAULT
static IPattern
u_Symbol
static IPattern
v_
Used to represent a formal patternv_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
v_DEFAULT
static IPattern
v_Symbol
static IPattern
w_
Used to represent a formal patternw_
that will be used only for predefined pattern-matching rules and can match one expression.static IPattern
w_DEFAULT
static IPattern
w_Symbol
static IPattern
x_
Used to represent a formal patternx_
that will be used only for predefined pattern-matching rules and can match one expression.static IPatternSequence
x__
Used to represent a formal pattern sequencex__
that will be used only for predefined pattern-matching rules and can match any sequence of one or more expressions.static IPatternSequence
x___
Used to represent a formal null pattern sequencex___
that will be used only for predefined pattern-matching rules and can match any sequence of zero or more expressions.static IPattern
x_DEFAULT
static IPattern
x_Symbol
static IPattern
y_
Used to represent a formal patterny_
that will be used only for predefined pattern-matching rules and can match one expression.static IPatternSequence
y__
Used to represent a formal pattern sequencey__
that will be used only for predefined pattern-matching rules and can match any sequence of one or more expressions.static IPatternSequence
y___
Used to represent a formal null pattern sequencey___
that will be used only for predefined pattern-matching rules and can match any sequence of zero or more expressions.static IPattern
y_DEFAULT
static IPattern
y_Symbol
static IPattern
z_
Used to represent a formal patternz_
that will be used only for predefined pattern-matching rules and can match one expression.static IPatternSequence
z__
Used to represent a formal pattern sequencez__
that will be used only for predefined pattern-matching rules and can match any sequence of one or more expressions.static IPatternSequence
z___
Used to represent a formal null pattern sequencez___
that will be used only for predefined pattern-matching rules and can match any sequence of zero or more expressions.static IPattern
z_DEFAULT
static IPattern
z_Symbol
-
Fields inherited from class org.matheclipse.core.expression.S
$Aborted, $Assumptions, $BaseDirectory, $Cancel, $CharacterEncoding, $Context, $ContextPath, $CreationDate, $DisplayFunction, $Failed, $HistoryLength, $HomeDirectory, $IdentityMatrix, $Input, $InputFileName, $IterationLimit, $Line, $MachineEpsilon, $MachinePrecision, $MaxMachineNumber, $MessageList, $MinMachineNumber, $Notebooks, $OperatingSystem, $OutputSizeLimit, $Packages, $Path, $PathnameSeparator, $PrePrint, $PreRead, $RecursionLimit, $RootDirectory, $Scaling, $ScriptCommandLine, $SingleEntryMatrix, $SystemCharacterEncoding, $SystemMemory, $TemporaryDirectory, $UserBaseDirectory, $UserName, $Version, a, AASTriangle, Abort, Abs, AbsArg, AbsoluteCorrelation, AbsoluteTime, AbsoluteTiming, Accumulate, AddSides, AddTo, AddToClassPath, AdjacencyMatrix, Adjugate, AiryAi, AiryAiPrime, AiryBi, AiryBiPrime, AlgebraicNumber, Algebraics, All, AllowedHeads, AllowShortContext, AllTrue, Alphabet, Alternatives, AmbientLight, And, AngleVector, Annotation, Annuity, AnnuityDue, AntihermitianMatrixQ, AntiSymmetric, AntisymmetricMatrixQ, AnyTrue, Apart, AppellF1, Append, AppendTo, Apply, ApplySides, ArcCos, ArcCosh, ArcCot, ArcCoth, ArcCsc, ArcCsch, ArcLength, ArcSec, ArcSech, ArcSin, ArcSinh, ArcTan, ArcTanh, Area, Arg, ArgMax, ArgMin, ArithmeticGeometricMean, Array, ArrayDepth, ArrayFlatten, ArrayPad, ArrayPlot, ArrayQ, ArrayReshape, ArrayRules, Arrays, Arrow, Arrowheads, ASATriangle, AspectRatio, AssociateTo, Association, AssociationMap, AssociationQ, AssociationThread, Assuming, Assumptions, ASymbol, AtomQ, Attributes, Automatic, AvogadroConstant, Axes, AxesLabel, AxesOrigin, AxesStyle, Axis, b, Background, Ball, BarChart, BarOrigin, BartlettWindow, BaseDecode, BaseEncode, BaseForm, Beep, Begin, BeginPackage, BeginTestSection, BellB, BellY, BernoulliB, BernoulliDistribution, BernoulliProcess, BernsteinBasis, BesselI, BesselJ, BesselJZero, BesselK, BesselY, BesselYZero, Beta, BetaDistribution, BetaRegularized, BetweennessCentrality, BezierFunction, BinaryDeserialize, BinaryDistance, BinaryRead, BinarySerialize, BinaryWrite, BinCounts, Binomial, BinomialDistribution, BinomialProcess, BioSequence, BioSequenceQ, BioSequenceTranscribe, BioSequenceTranslate, BitLength, Black, BlackmanHarrisWindow, BlackmanNuttallWindow, BlackmanWindow, Blank, BlankNullSequence, BlankSequence, Block, Blue, BohrRadius, Boole, BooleanConvert, BooleanFunction, BooleanMaxterms, BooleanMinimize, BooleanMinterms, BooleanQ, Booleans, BooleanTable, BooleanVariables, Bottom, Boxed, BoxRatios, BoxWhiskerChart, BrayCurtisDistance, Break, Brown, BrownianBridgeProcess, BSplineFunction, BSymbol, Button, Byte, ByteArray, ByteArrayQ, ByteArrayToString, ByteCount, c, C, CanberraDistance, Cancel, CancelButton, CarlsonRC, CarlsonRD, CarlsonRF, CarlsonRG, CarlsonRJ, CarmichaelLambda, CartesianProduct, Cases, Catalan, CatalanNumber, Catch, Catenate, CauchyDistribution, CDF, Ceiling, Center, CenterDot, CentralMoment, CForm, Character, CharacterEncoding, CharacteristicPolynomial, CharacterRange, Characters, ChebyshevT, ChebyshevU, Check, CheckAbort, ChessboardDistance, ChineseRemainder, ChiSquareDistribution, CholeskyDecomposition, Chop, Circle, CircleDot, CirclePoints, CircleTimes, Clear, ClearAll, ClearAttributes, ClebschGordan, Clip, Close, ClosenessCentrality, CMYColor, Coefficient, CoefficientArrays, CoefficientList, CoefficientRules, Cofactor, Collect, CollinearPoints, Colon, ColorData, ColorFunction, Column, Commonest, CompatibleUnitQ, Compile, CompiledFunction, CompilePrint, Complement, CompleteGraph, Complex, Complexes, ComplexExpand, ComplexInfinity, ComplexityFunction, ComplexPlot3D, ComposeList, ComposeSeries, CompositeQ, Composition, CompoundExpression, Condition, ConditionalExpression, Cone, Conjugate, ConjugateTranspose, ConnectedGraphQ, Constant, ConstantArray, ContainsAll, ContainsAny, ContainsExactly, ContainsNone, ContainsOnly, Context, Continue, ContinuedFraction, ContourPlot, Convergents, ConvexHullMesh, CoordinateBoundingBox, CoordinateBounds, CoplanarPoints, CoprimeQ, Correlation, CorrelationDistance, Cos, Cosh, CoshIntegral, CosineDistance, CosIntegral, Cot, Coth, Count, CountDistinct, Counts, Covariance, CreateDirectory, CreateFile, Cross, Csc, Csch, CSymbol, Cube, CubeRoot, Cuboid, Curl, Cyan, CycleGraph, Cycles, Cyclotomic, Cylinder, d, D, Dashed, Dashing, DataRange, Dataset, DateObject, DateString, DateValue, Decrement, DedekindNumber, Default, DefaultButton, DefaultValue, Defer, Definition, Degree, DegreeLexicographic, DegreeReverseLexicographic, Delete, DeleteCases, DeleteDuplicates, DeleteDuplicatesBy, DeleteMissing, Delimiters, Denominator, DensityHistogram, DensityPlot, Depth, Derivative, DesignMatrix, Det, Diagonal, DiagonalMatrix, DiagonalMatrixQ, DialogInput, DialogNotebook, DialogReturn, DiceDissimilarity, DifferenceDelta, Differences, DigitCharacter, DigitCount, DigitQ, Dimensions, DiracDelta, DirectedEdge, DirectedEdges, DirectedInfinity, Direction, DirectionalLight, Directive, DirichletEta, DirichletWindow, DiscreteDelta, DiscretePlot, DiscreteUniformDistribution, Discriminant, DisjointQ, Disk, Dispatch, DisplayForm, DisplayFunction, Disputed, DistanceFunction, Distribute, Distributed, Div, Divide, DivideBy, DivideSides, Divisible, Divisors, DivisorSigma, DivisorSum, Do, Dodecahedron, Dot, DotDashed, Dotted, DownValues, Drop, DSolve, Dt, DuplicateFreeQ, Dynamic, e, E, EasterSunday, Echo, EchoFunction, EdgeCount, EdgeForm, EdgeLabels, EdgeList, EdgeQ, EdgeRules, EdgeShapeFunction, EdgeStyle, EdgeWeight, EditDistance, EffectiveInterest, Eigensystem, Eigenvalues, EigenvectorCentrality, Eigenvectors, Element, ElementData, Eliminate, EliminationOrder, Ellipsoid, EllipticE, EllipticF, EllipticK, EllipticPi, EllipticTheta, End, EndOfFile, EndOfLine, EndOfString, EndPackage, EndTestSection, Entity, Entropy, Equal, EqualTo, Equivalent, Erf, Erfc, Erfi, ErlangDistribution, EuclideanDistance, EulerE, EulerGamma, EulerianGraphQ, EulerPhi, Evaluate, EvenQ, ExactNumberQ, Except, Exists, Exit, Exp, Expand, ExpandAll, Expectation, ExpIntegralE, ExpIntegralEi, Exponent, ExponentialDistribution, Export, ExportString, Expression, ExpToTrig, ExtendedGCD, Extension, Extract, f, f1, f2, f3, f4, Factor, Factorial, Factorial2, FactorialPower, FactorInteger, FactorSquareFree, FactorSquareFreeList, FactorTerms, FactorTermsList, False, Fibonacci, File, FileFormat, FileHash, FileNameJoin, FileNames, FileNameTake, FilePrint, Filling, FillingStyle, FilterRules, FindClusters, FindCycle, FindEdgeCover, FindEulerianCycle, FindFit, FindGraphCommunities, FindGraphIsomorphism, FindHamiltonianCycle, FindIndependentEdgeSet, FindIndependentVertexSet, FindInstance, FindLinearRecurrence, FindMaximum, FindMinimum, FindPermutation, FindRoot, FindShortestPath, FindShortestTour, FindSpanningTree, FindVertexCover, First, FirstCase, FirstPosition, Fit, FittedModel, FiveNum, FixedPoint, FixedPointList, Flat, Flatten, FlattenAt, FlatTopWindow, Float, Floor, Fold, FoldList, For, ForAll, FormBox, Fourier, FourierDCT, FourierDCTMatrix, FourierDST, FourierDSTMatrix, FourierMatrix, FractionalPart, FractionBox, FRatioDistribution, FrechetDistribution, FreeQ, FresnelC, FresnelS, FrobeniusNumber, FrobeniusSolve, FromCharacterCode, FromContinuedFraction, FromDigits, FromLetterNumber, FromPolarCoordinates, FromRomanNumeral, FromSphericalCoordinates, FSymbol, Full, FullForm, FullSimplify, Function, FunctionDomain, FunctionExpand, FunctionRange, FunctionURL, g, Gamma, GammaDistribution, GammaRegularized, Gather, GatherBy, GaussianIntegers, GaussianMatrix, GaussianWindow, GCD, GegenbauerC, General, GenerateConditions, GeodesyData, GeoDistance, GeometricDistribution, GeometricMean, GeometricTransformation, GeoPosition, Get, Glaisher, GoldenAngle, GoldenRatio, GompertzMakehamDistribution, Grad, Graph, GraphCenter, GraphComplement, GraphData, GraphDiameter, GraphDifference, GraphDisjointUnion, Graphics, Graphics3D, Graphics3DJSON, GraphicsComplex, GraphicsGroup, GraphicsJSON, GraphIntersection, GraphPeriphery, GraphQ, GraphRadius, GraphUnion, Gray, GrayLevel, Greater, GreaterEqual, GreaterEqualThan, GreaterThan, Green, GroebnerBasis, GroupBy, GSymbol, Gudermannian, GumbelDistribution, h, HamiltonianGraphQ, HammingDistance, HammingWindow, HankelH1, HankelH2, HannWindow, HarmonicMean, HarmonicNumber, Haversine, Head, Heads, HeavisideTheta, HermiteH, HermitianMatrixQ, HessenbergDecomposition, HexidecimalCharacter, HilbertMatrix, Histogram, HodgeDual, Hold, HoldAll, HoldAllComplete, HoldComplete, HoldFirst, HoldForm, HoldPattern, HoldRest, Horner, HornerForm, Hue, HurwitzLerchPhi, HurwitzZeta, HypercubeGraph, Hyperfactorial, Hypergeometric0F1, Hypergeometric1F1, Hypergeometric1F1Regularized, Hypergeometric2F1, Hypergeometric2F1Regularized, HypergeometricDistribution, HypergeometricPFQ, HypergeometricPFQRegularized, HypergeometricU, i, I, Icosahedron, Identity, IdentityMatrix, If, IgnoreCase, Im, Image, ImageChannels, ImageColorSpace, ImageCrop, ImageData, ImageDimensions, ImageQ, ImageResize, ImageRotate, ImageScaled, ImageSize, ImageType, ImplicitD, Implies, Import, ImportString, In, Increment, Indeterminate, IndexGraph, Inequality, InexactNumberQ, Infinity, Infix, Information, Inherited, Inner, Input, InputField, InputForm, InputStream, InputString, Insert, InsertionFunction, InstallJava, InstanceOf, Integer, IntegerDigits, IntegerExponent, IntegerLength, IntegerName, IntegerPart, IntegerPartitions, IntegerQ, Integers, Integrate, InterpolatingFunction, InterpolatingPolynomial, Interpolation, InterpolationOrder, InterquartileRange, Interrupt, IntersectingQ, Intersection, Interval, IntervalComplement, IntervalData, IntervalIntersection, IntervalMemberQ, IntervalUnion, Inverse, InverseBetaRegularized, InverseCDF, InverseErf, InverseErfc, InverseFourier, InverseFunction, InverseGammaRegularized, InverseGudermannian, InverseHaversine, InverseJacobiCD, InverseJacobiCN, InverseJacobiDC, InverseJacobiDN, InverseJacobiNC, InverseJacobiND, InverseJacobiSC, InverseJacobiSD, InverseJacobiSN, InverseLaplaceTransform, InverseSeries, InverseWeierstrassP, InverseZTransform, IsomorphicGraphQ, j, JaccardDissimilarity, JacobiAmplitude, JacobiCD, JacobiCN, JacobiDC, JacobiDN, JacobiEpsilon, JacobiMatrix, JacobiNC, JacobiND, JacobiP, JacobiSC, JacobiSD, JacobiSN, JacobiSymbol, JacobiZeta, JavaClass, JavaForm, JavaNew, JavaObject, JavaObjectQ, JavaShow, Join, Joined, JSForm, JSFormData, k, KelvinBei, KelvinBer, Key, KeyAbsent, KeyExistsQ, Keys, KeySelect, KeySort, KeyTake, Khinchin, KleinInvariantJ, KnownUnitQ, KolmogorovSmirnovTest, KOrderlessPartitions, KPartitions, KroneckerDelta, KroneckerProduct, Kurtosis, l, Labeled, LabelingFunction, LabelingSize, LaguerreL, LambertW, LaplaceTransform, Large, Last, LCM, LeafCount, LeastSquares, Left, LegendreP, LegendreQ, Length, LengthWhile, LerchPhi, Less, LessEqual, LessEqualThan, LessThan, LetterCharacter, LetterCounts, LetterNumber, LetterQ, Level, LevelQ, LeviCivitaTensor, Lexicographic, LHS_HEAD, LightBlue, LightBrown, LightCyan, LightGray, LightGreen, Lighting, LightMagenta, LightOrange, LightPink, LightPurple, LightRed, LightYellow, Limit, Line, LinearModelFit, LinearOptimization, LinearProgramming, LinearRecurrence, LinearSolve, LinearSolveFunction, LineGraph, LiouvilleLambda, List, Listable, ListContourPlot, ListConvolve, ListCorrelate, ListDensityPlot, ListLinePlot, ListLinePlot3D, ListLogLinearPlot, ListLogLogPlot, ListLogPlot, ListPlot, ListPlot3D, ListPointPlot3D, ListPolarPlot, ListQ, ListStreamPlot, ListVectorPlot, Literal, LoadJavaClass, Locked, Log, Log10, Log2, LogGamma, LogicalExpand, LogIntegral, LogisticSigmoid, LogLinearPlot, LogLogPlot, LogNormalDistribution, LogPlot, Longest, LongForm, Lookup, LowerCaseQ, LowerTriangularize, LowerTriangularMatrixQ, LucasL, LUDecomposition, m, MachineNumberQ, Magenta, MakeBoxes, MangoldtLambda, ManhattanDistance, Manipulate, MantissaExponent, Map, MapAll, MapAt, MapIndexed, MapThread, MatchingDissimilarity, MatchQ, MathMLForm, Matrices, MatrixD, MatrixExp, MatrixForm, MatrixFunction, MatrixLog, MatrixMinimalPolynomial, MatrixPlot, MatrixPower, MatrixQ, MatrixRank, Max, MaxFilter, Maximize, MaxIterations, MaxMemoryUsed, MaxPoints, Mean, MeanDeviation, MeanFilter, Median, MedianFilter, Medium, MeijerG, MemberQ, MemoryAvailable, MemoryInUse, MersennePrimeExponent, MersennePrimeExponentQ, Mesh, MeshRange, Message, MessageName, Messages, Method, Min, MinFilter, MinimalPolynomial, Minimize, MinMax, Minor, Minors, Minus, Missing, MissingQ, Mod, ModularInverse, Module, Modulus, MoebiusMu, MonomialList, MonomialOrder, Most, Multinomial, MultiplicativeOrder, MultiplySides, n, N, NakagamiDistribution, NameQ, Names, Nand, ND, NDSolve, Nearest, NearestTo, Needs, Negative, NegativeDegreeLexicographic, NegativeDegreeReverseLexicographic, NegativeIntegers, NegativeLexicographic, NegativeRationals, NegativeReals, Nest, NestList, NestWhile, NestWhileList, NewLimit, NextPrime, NFourierTransform, NHoldAll, NHoldFirst, NHoldRest, NIntegrate, NMaximize, NMinimize, NonCommutativeMultiply, None, NoneTrue, Nonexistent, NonNegative, NonNegativeIntegers, NonNegativeRationals, NonNegativeReals, NonPositive, Nor, Norm, Normal, NormalDistribution, Normalize, NormalMatrixQ, Not, NotApplicable, NotAvailable, NotElement, Nothing, NotListQ, Now, NRoots, NSolve, Null, NullSpace, Number, NumberFieldRootsOfUnity, NumberLinePlot, NumberQ, NumberString, Numerator, NumericalOrder, NumericalSort, NumericArray, NumericArrayQ, NumericArrayType, NumericFunction, NumericQ, NuttallWindow, o, O, Octahedron, OddQ, Off, On, OneIdentity, Opacity, OpenAppend, OpenRead, OpenWrite, Operate, OptimizeExpression, Optional, Options, OptionsPattern, OptionValue, Or, Orange, Order, OrderedQ, Ordering, Orderless, Orthogonalize, OrthogonalMatrixQ, Out, Outer, OutputForm, OutputStream, Overflow, Overlaps, Overscript, OverscriptBox, OwnValues, p, Package, PadeApproximant, PadLeft, PadRight, ParallelMap, ParametricPlot, Parenthesis, ParetoDistribution, Part, Partition, PartitionsP, PartitionsQ, ParzenWindow, PathGraph, PathGraphQ, Pattern, PatternOrder, PatternTest, PauliMatrix, Pause, PDF, PearsonChiSquareTest, PearsonCorrelationTest, PerfectNumber, PerfectNumberQ, Perimeter, PermutationCycles, PermutationCyclesQ, PermutationList, PermutationListQ, PermutationReplace, Permutations, Permute, PetersenGraph, Pi, Pick, Piecewise, PiecewiseExpand, PieChart, Pink, PlanarGraph, PlanarGraphQ, Plot, Plot3D, PlotLegends, PlotRange, PlotStyle, Plus, PlusMinus, Pochhammer, Point, PointLight, PointSize, PoissonDistribution, PoissonProcess, PolarPlot, PolyGamma, Polygon, PolygonalNumber, Polyhedron, PolyLog, PolynomialExtendedGCD, PolynomialGCD, PolynomialLCM, PolynomialQ, PolynomialQuotient, PolynomialQuotientRemainder, PolynomialRemainder, Position, Positive, PositiveIntegers, PositiveRationals, PositiveReals, PossibleZeroQ, Postfix, Power, PowerExpand, PowerMod, PrecedenceForm, Precision, PrecisionGoal, PreDecrement, Prefix, PreIncrement, Prepend, PrependTo, Prime, PrimeOmega, PrimePi, PrimePowerQ, PrimeQ, Primes, PrimitiveRoot, PrimitiveRootList, PrincipalComponents, Print, PrintableASCIIQ, Prism, Probability, Product, ProductLog, Projection, Protect, Protected, PseudoInverse, PSymbol, Purple, Put, Pyramid, q, QRDecomposition, QSymbol, QuadraticIrrationalQ, Quantile, Quantity, QuantityDistribution, QuantityMagnitude, QuantityQ, QuantityUnit, QuarticSolve, Quartiles, Quiet, Quit, Quotient, QuotientRemainder, r, RadicalBox, Ramp, RamseyNumber, RandomChoice, RandomComplex, RandomGraph, RandomInteger, RandomPermutation, RandomPrime, RandomReal, RandomSample, RandomVariate, Range, RankedMax, RankedMin, Rational, Rationalize, Rationals, RawBoxes, Re, Read, ReadList, ReadProtected, ReadString, Real, RealAbs, RealDigits, Reals, RealSign, RealValuedNumberQ, RealValuedNumericQ, Reap, Record, RecordSeparators, Rectangle, Red, Reduce, Refine, RegularExpression, ReIm, ReleaseHold, Remove, RemoveDiacritics, Repeated, RepeatedNull, RepeatedTiming, Replace, ReplaceAll, ReplaceList, ReplacePart, ReplaceRepeated, Rescale, Rest, Resultant, Return, Reverse, RGBColor, RiccatiSolve, Riffle, Right, RightComposition, RogersTanimotoDissimilarity, RomanNumeral, Root, RootIntervals, RootOf, RootReduce, Roots, RotateLeft, RotateRight, RotationMatrix, RotationTransform, Round, Row, RowBox, RowReduce, RSolve, RSolveValue, Rule, RuleDelayed, RussellRaoDissimilarity, s, SameObjectQ, SameQ, SameTest, SASTriangle, SatisfiabilityCount, SatisfiabilityInstances, SatisfiableQ, SawtoothWave, Scale, Scaled, ScalingFunctions, ScalingTransform, Scan, SchurDecomposition, Sec, Sech, Second, SeedRandom, Select, SelectFirst, SemanticImport, SemanticImportString, Sequence, SequenceCases, SequenceHold, SequenceReplace, SequenceSplit, Series, SeriesCoefficient, SeriesData, Set, SetAttributes, SetDelayed, SetSystemOptions, Share, ShearingTransform, Short, Shortest, Show, Sign, Signature, SignCmp, Simplex, Simplify, Sin, Sinc, SingularValueDecomposition, SingularValueList, Sinh, SinhIntegral, SinIntegral, SixJSymbol, Skewness, Slot, SlotAbsent, SlotSequence, Small, SokalSneathDissimilarity, Solve, Sort, SortBy, Sow, Span, SparseArray, Specularity, Sphere, SphericalBesselJ, SphericalBesselY, SphericalHankelH1, SphericalHankelH2, SphericalHarmonicY, Split, SplitBy, SpotLight, Sqrt, SqrtBox, SquaredEuclideanDistance, SquareFreeQ, SquareMatrixQ, SSSTriangle, Stack, StackBegin, StandardDeviation, StandardForm, Standardize, StarGraph, StartOfLine, StartOfString, StaticsVisible, StieltjesGamma, StirlingS1, StirlingS2, StreamPlot, Strict, String, StringCases, StringContainsQ, StringCount, StringDrop, StringExpression, StringForm, StringFormat, StringFreeQ, StringInsert, StringJoin, StringLength, StringMatchQ, StringPart, StringPosition, StringQ, StringRepeat, StringReplace, StringReverse, StringRiffle, StringSplit, StringTake, StringTemplate, StringToByteArray, StringToStream, StringTrim, Structure, StruveH, StruveL, StudentTDistribution, Style, StyleForm, Subdivide, Subfactorial, Subscript, SubscriptBox, SubsetQ, Subsets, Subsuperscript, SubsuperscriptBox, Subtract, SubtractFrom, SubtractSides, Sum, Summary, Superscript, SuperscriptBox, Surd, SurfaceArea, SurfaceGraphics, SurvivalFunction, Switch, Symbol, SymbolName, SymbolQ, Symmetric, SymmetricMatrixQ, SyntaxLength, SyntaxQ, SystemDialogInput, SystemOptions, t, Table, TableAlignments, TableDepth, TableDirections, TableForm, TableHeadings, TableSpacing, TagSet, TagSetDelayed, Take, TakeLargest, TakeLargestBy, TakeSmallest, TakeSmallestBy, TakeWhile, Tally, Tan, Tanh, TargetFunctions, TautologyQ, Taylor, TemplateApply, TemplateExpression, TemplateIf, TemplateSlot, TensorDimensions, TensorProduct, TensorRank, TensorSymmetry, TestID, TestReport, TestReportObject, TestResultObject, Tetrahedron, TeXForm, Text, TextCell, TextElement, TextString, TextStructure, Thickness, Thread, ThreeJSymbol, Through, Throw, Ticks, TicksStyle, TimeConstrained, TimeObject, TimeRemaining, Times, TimesBy, TimeValue, Timing, Tiny, ToBoxes, ToCharacterCode, Today, ToeplitzMatrix, ToExpression, Together, ToIntervalData, ToLowerCase, TooLarge, Top, ToPolarCoordinates, ToRadicals, ToSphericalCoordinates, ToString, Total, ToUnicode, ToUpperCase, Tr, Trace, TraceForm, TraditionalForm, TransformationFunction, TranslationTransform, Transliterate, Transpose, TreeForm, Triangle, Trig, TrigExpand, TrigReduce, TrigSimplifyFu, TrigToExp, True, TrueQ, TTest, Tube, TukeyWindow, Tuples, TwoWayRule, u, Undefined, Underflow, Underoverscript, UnderoverscriptBox, Underscript, UnderscriptBox, UndirectedEdge, Unequal, UnequalTo, Unevaluated, UniformDistribution, Union, Unique, UnitaryMatrixQ, UnitConvert, Unitize, UnitStep, UnitTriangle, UnitVector, UniverseAge, Unknown, Unprotect, UnsameQ, Unset, UpperCaseQ, UpperTriangularize, UpperTriangularMatrixQ, UpSet, UpSetDelayed, UpTo, UpValues, URLFetch, UseTypeChecking, v, ValueQ, Values, VandermondeMatrix, Variable, Variables, Variance, VectorAngle, VectorGreater, VectorGreaterEqual, VectorLess, VectorLessEqual, VectorPlot, VectorQ, Vectors, Verbatim, VerificationTest, VertexEccentricity, VertexLabels, VertexList, VertexQ, VertexShapeFunction, VertexSize, VertexStyle, ViewPoint, Volume, w, WeaklyConnectedGraphQ, WeberE, WeibullDistribution, WeierstrassHalfPeriods, WeierstrassInvariants, WeierstrassP, WeierstrassPPrime, WeightedAdjacencyMatrix, WeightedData, WeightedGraphQ, WheelGraph, Which, While, White, Whitespace, WhitespaceCharacter, WhittakerM, WhittakerW, With, Word, WordBoundary, WordCharacter, WordSeparators, Write, WriteString, x, Xnor, Xor, y, Yellow, YuleDissimilarity, z, ZeroSymmetric, ZeroTest, Zeta, ZTransform
-
-
Constructor Summary
Constructors Constructor Description F()
-
Method Summary
All Methods Static Methods Concrete Methods Deprecated Methods Modifier and Type Method Description static IASTMutable
$(IExpr head, IExpr... a)
Create a new abstract syntax tree (AST).static IPattern
$b()
Create aBlank[]
pattern object for pattern-matching and term rewritingstatic IPattern
$b(IExpr condition)
Create aBlank[condition]
pattern object for pattern-matching and term rewritingstatic IPattern
$b(IExpr condition, boolean def)
Create aBlank[condition]
pattern object for pattern-matching and term rewritingstatic PatternSequence
$bns(IExpr condition)
Create aBlankNullSequence[condition]
pattern object for pattern-matching and term rewritingstatic PatternSequence
$bs(IExpr condition)
Create aBlankSequence[condition]
pattern object for pattern-matching and term rewritingstatic IPatternSequence
$OptionsPattern()
static IPatternSequence
$OptionsPattern(ISymbol symbol)
static IPatternSequence
$OptionsPattern(ISymbol symbol, IExpr defaultOptions)
static IPattern
$p(String symbolName)
Create a pattern for pattern-matching and term rewritingstatic IPattern
$p(String symbolName, boolean def)
Create a pattern for pattern-matching and term rewritingstatic IPattern
$p(String symbolName, IExpr check)
Create a pattern for pattern-matching and term rewritingstatic IPattern
$p(String symbolName, IExpr check, boolean def)
Create a pattern for pattern-matching and term rewritingstatic IPattern
$p(ISymbol symbol)
Create aPattern[]
pattern for pattern-matching and term rewritingstatic IPattern
$p(ISymbol symbol, boolean matchDefaultValue)
Create a pattern for pattern-matching and term rewritingstatic IPattern
$p(ISymbol symbol, IExpr headerCheck)
Create a pattern for pattern-matching and term rewritingstatic IPattern
$p(ISymbol symbol, IExpr headerCheck, boolean matchDefaultValue)
Create a pattern for pattern-matching and term rewritingstatic IPatternSequence
$ps(String symbolName)
Create a pattern for pattern-matching and term rewritingstatic IPatternSequence
$ps(ISymbol symbol)
Create a new PatternSequenceBlankSequence
.static IPatternSequence
$ps(ISymbol symbol, boolean zeroArgsAllowed)
Create a new PatternSequenceBlankSequence
orBlankNullSequence
.static IPatternSequence
$ps(ISymbol symbol, IExpr check)
Create a new PatternSequenceBlankSequence
orBlankNullSequence
.static IPatternSequence
$ps(ISymbol symbol, IExpr check, boolean def, boolean zeroArgsAllowed)
Create a new PatternSequenceBlankSequence
orBlankNullSequence
.static IPatternSequence
$Repeated(IExpr patternExpr, int min, int max, EvalEngine engine)
static ISymbol
$rubi(String symbolName)
static ISymbol
$rubi(String symbolName, IEvaluator evaluator)
static ISymbol
$s(String symbolName)
Get or create a global predefined symbol which is retrieved from the SYSTEM context map or created or retrieved from the SYSTEM context variables map.static IStringX
$str(char ch)
static IStringX
$str(String str)
Create a string expressionstatic IStringX
$str(String str, short mimeType)
static IAST
Abs(IExpr z)
static IAST
AbsoluteCorrelation(IExpr a0, IExpr a1)
static IASTMutable
AddSides(IExpr equationOrInequality, IExpr a1)
static IAST
AiryAi(IExpr a0)
static IAST
AiryAiPrime(IExpr a0)
static IAST
AiryBi(IExpr a0)
static IAST
AiryBiPrime(IExpr a0)
static int
allocLevel1(IAST ast, Predicate<IExpr> predicate)
Calulate the allocation size for a newIAST
object.static int
allocMax16(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 15,static int
allocMax32(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 31,static int
allocMax64(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 63,static int
allocMax8(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 7,static int
allocMin16(int size)
Determine the minimum of thesize
and integer number 15static int
allocMin16(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 15static int
allocMin32(int size)
Determine the minimum of thesize
and integer number 31static int
allocMin32(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 31,static int
allocMin64(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 63,static int
allocMin8(int size)
Determine the minimum of thesize
and integer number 7static int
allocMin8(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 7static IAST
Alternatives(IExpr... a)
static IASTMutable
AmbientLight(IExpr color)
static IExpr
and(Integer i, IExpr b)
static IExpr
and(BigInteger i, IExpr b)
static IExpr
and(IExpr a, Integer i)
static IExpr
and(IExpr a, BigInteger i)
static IASTAppendable
And()
static IAST
And(IExpr... expr)
static IAST
And(IExpr expr1, IExpr expr2)
static IAST
And(IExpr expr1, IExpr expr2, IExpr expr3)
static IAST
AngleVector(IExpr a0)
static IAST
AntiSymmetric(IExpr a0)
static IAST
Apart(IExpr a0)
static IAST
Apart(IExpr a0, IExpr a1)
static IAST
AppellF1(IExpr a, IExpr b1, IExpr b2, IExpr c, IExpr z1, IExpr z2)
static IAST
Append(IExpr a0, IExpr a1)
static IAST
AppendTo(IExpr a0, IExpr a1)
static IASTMutable
Apply(IExpr a0, IExpr a1)
Operator@@
static IASTMutable
ApplyListC1(IExpr a0, IExpr a1)
Operator@@@
static IASTMutable
ApplySides(IExpr a0, IExpr equationOrInequality)
static IAST
ArcCos(IExpr z)
static IAST
ArcCosh(IExpr z)
static IAST
ArcCot(IExpr z)
static IAST
ArcCoth(IExpr z)
static IAST
ArcCsc(IExpr z)
static IAST
ArcCsch(IExpr z)
static IAST
ArcSec(IExpr z)
static IAST
ArcSech(IExpr z)
static IAST
ArcSin(IExpr z)
static IAST
ArcSinh(IExpr z)
static IAST
ArcTan(IExpr z)
static IAST
ArcTan(IExpr x, IExpr y)
static IAST
ArcTanh(IExpr z)
static IAST
Arg(IExpr z)
static IAST
ArithmeticGeometricMean(IExpr a0, IExpr a1)
static IAST
Array(IExpr a0, IExpr a1)
static IAST
ArrayQ(IExpr a0)
'ArrayQ(expr)static IAST
Arrays(IAST dimension)
The domain of arrays.static IAST
Arrays(IAST dimension, ISymbol domain)
The domain of arrays.static IAST
Arrays(IAST dimension, ISymbol domain, IAST symmetry)
The domain of arrays.static IAST
Arrays(IExpr a0)
static IAST
Arrays(IExpr a0, IExpr a1)
static IAST
Arrays(IExpr a0, IExpr a1, IExpr a2)
static IAssociation
assoc()
static IAssociation
assoc(IAssociation templateAssociation, Map<IExpr,IASTMutable> mapOfRules)
Create an association data structure<| x0->y0, x1->y1, ...
static IAssociation
assoc(IAST listOfRules)
Create an association data structure<| x0->y0, x1->y1, ...
static IAST
ast(IAST f, IExpr head, boolean include, int first, int last)
Creates a new AST from the givenast
andhead
.static IASTAppendable
ast(IExpr head)
Create a new abstract syntax tree (AST).static IASTAppendable
ast(IExpr[] arr, IExpr head)
Create a new function expression (AST - abstract syntax tree).static IASTAppendable
ast(IExpr head, int initialCapacity)
Create a new abstract syntax tree (AST).static IASTAppendable
ast(IExpr head, int initialCapacity, boolean initNull)
Deprecated.static IASTAppendable
ast(IExpr head, Collection<? extends IExpr> collection)
Create a new abstract syntax tree (AST).static IASTAppendable
ast(IExpr head, Collection<? extends IExpr> collection, int initialCapacity)
static IASTAppendable
ast(ISymbol head, boolean evalComplex, org.hipparchus.complex.Complex[] arr)
Create a new function expression (AST - abstract syntax tree), where all arguments are JavaComplexNum
values.static IASTAppendable
ast(ISymbol head, int[] arr)
Create a new function expression (AST - abstract syntax tree), where all arguments are Javaint
values.static IASTAppendable
ast(ISymbol head, org.hipparchus.complex.Complex[] arr)
Create a new function expression (AST - abstract syntax tree), where all arguments are Javaorg.hipparchus.complex.Complex
values.static IASTMutable
astMutable(IExpr head, int initialCapacity)
Create a new abstract syntax tree (AST) with pre- allocated elements set tonull
.static IAST
AtomQ(IExpr a)
AtomQ(x)static IAST
Attributes(IExpr a)
static void
await()
Causes the current thread to wait until the main initialization has finished.static IAST
BaseForm(IExpr a0, IExpr a1)
static IAST
BellB(IExpr a0)
Bell number.static IAST
BellB(IExpr a0, IExpr a1)
Bell polynomial.static IAST
BellY(IExpr a0, IExpr a1, IExpr a2)
static IAST
BernoulliB(IExpr a0)
static IAST
BernoulliB(IExpr a0, IExpr a1)
static IAST
BernoulliDistribution(IExpr a0)
static IAST
BesselI(IExpr a0, IExpr a1)
static IAST
BesselJ(IExpr a0, IExpr a1)
static IAST
BesselK(IExpr a0, IExpr a1)
static IAST
BesselY(IExpr a0, IExpr a1)
static IAST
Beta(IExpr a0, IExpr a1)
static IAST
Beta(IExpr a0, IExpr a1, IExpr a2)
static IAST
BetaRegularized(IExpr a0, IExpr a1, IExpr a2)
static IAST
BetaRegularized(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IASTAppendable
binary(IExpr head, IExpr arg1, IExpr arg2)
Create a functionhead(arg1, arg2)
with 2 arguments without evaluation.static IASTMutable
binaryAST2(IExpr head, String arg1, String arg2)
static IASTMutable
binaryAST2(IExpr head, String arg1, IExpr arg2)
static IASTMutable
binaryAST2(IExpr head, IExpr arg1, IExpr arg2)
Create a functionhead(arg1, arg2)
with 2 argument as anAST2
mutable object without evaluation.static IAST
Binomial(int a0, int a1)
static IAST
Binomial(IExpr a0, IExpr a1)
static IAST
BinomialDistribution(IExpr a0, IExpr a1)
static IAST
BlankSequence()
static IAST
Block(IExpr a0, IExpr a1)
static ISymbol
bool(boolean value)
Deprecated.usebooleSymbol(boolean)
insteadstatic IAST
Boole(IExpr a)
static IAST
BooleanConvert(IExpr a0, IExpr a1)
static IAST
BooleanMinimize(IExpr a)
static IAST
BooleanQ(IExpr a)
BooleanQ(expr)static IAST
BooleanTable(IExpr a0, IExpr a1)
static IAST
BooleanVariables(IExpr a0)
static IInteger
booleInteger(boolean value)
Returns integers 1 or 0 (type ISymbol) depending on the boolean valuetrue
orfalse
.static ISymbol
booleSymbol(boolean value)
Returns symbol "True" or "False" (type ISymbol) depending on the boolean value.static IAST
Break()
static IAST
BrownianBridgeProcess(IExpr a0, IExpr a1, IExpr a2)
static IAST
C(int index)
static IAST
Cancel(IExpr a)
static IAST
CancelButton()
static IAST
CarlsonRC(IExpr a0, IExpr a1)
static IAST
CarlsonRD(IExpr a0, IExpr a1, IExpr a2)
static IAST
CarlsonRF(IExpr a0, IExpr a1, IExpr a2)
static IAST
CarlsonRG(IExpr a0, IExpr a1, IExpr a2)
static IAST
CarmichaelLambda(IExpr a0)
static IExpr
cast(Object obj)
Converts a given object into a MathEclipse IExpr expressionstatic IAST
CatalanNumber(IExpr a)
static IAST
Catch(IExpr a)
static IAST
CauchyDistribution(IExpr a0, IExpr a1)
static IComplex
CC(long real, long imag)
Create a symbolic complex numberreal + I * imag
.static IComplex
CC(long realNumerator, long realDenominator, long imagNumerator, long imagDenominator)
Create a symbolic complex number(realNumerator/realDenominator) + I * (imagNumerator/imagDenominator)
static IComplex
CC(IFraction re)
Create a symbolic complex numberre + I * 0
static IComplex
CC(IRational real, IRational imag)
Create a symbolic complex numberreal + I * imag
static IAST
CDF(IExpr distribution)
static IAST
CDF(IExpr distribution, IExpr a1)
static IAST
Ceiling(IExpr z)
static IAST
CentralMoment(IExpr a0, IExpr a1)
static IAST
CharacteristicPolynomial(IExpr matrix, IExpr variable)
CharacteristicPolynomial(matrix, var) - computes the characteristic polynomial of a `matrix` for the variable `var`.static IAST
ChebyshevT(IExpr a0, IExpr a1)
static IAST
ChebyshevU(IExpr a0, IExpr a1)
static IAST
Chop(IExpr a0)
static org.hipparchus.complex.Complex
chopComplex(org.hipparchus.complex.Complex arg)
Set real or imaginary parts of a numeric argument to zero, those absolute value is less thanConfig.DEFAULT_CHOP_DELTA
static org.hipparchus.complex.Complex
chopComplex(org.hipparchus.complex.Complex arg, double delta)
Set real or imaginary parts of a numeric argument to zero, those absolute value is less than a delta.static IExpr
chopExpr(IExpr arg, double delta)
static INumber
chopNumber(INumber arg, double delta)
Set real or imaginary parts of a numeric argument to zero, those absolute value is less than a delta.static IAST
Circle(IAST originList)
static IAST
Clear(IExpr... a)
static IAST
ClearAttributes(IExpr a0, IExpr a1)
static IAST
ClebschGordan(IExpr arg1, IExpr arg2, IExpr arg3)
static IAST
Clip(IExpr a0)
static IAST
Clip(IExpr a0, IExpr a1)
static IAST
Coefficient(IExpr a0, IExpr a1)
static IAST
Coefficient(IExpr a0, IExpr a1, IExpr a2)
static IAST
CoefficientList(IExpr a0, IExpr a1)
static IAST
Collect(IExpr a0, IExpr a1)
static IAST
Colon(IExpr a0, IExpr a1)
static int
compareTo(Integer i, IExpr b)
static int
compareTo(BigInteger i, IExpr b)
static int
compareTo(IExpr a, Integer i)
static int
compareTo(IExpr a, BigInteger i)
static int
compareTo(IExpr a, IExpr b)
static IAST
Compile(IExpr a0, IExpr a1)
static IAST
CompilePrint(IExpr a0, IExpr a1)
static IAST
Complement(IExpr a0, IExpr a1)
static IComplex
complex(double realPart, double imagPart)
Create a symbolic complex numberstatic IComplex
complex(double realPart, double imagPart, double epsilon)
Create a symbolic complex numberstatic IComplex
complex(long real_numerator, long real_denominator, long imag_numerator, long imag_denominator)
Create a symbolic complex numberstatic IComplex
complex(IRational re)
Create a symbolic complex numberstatic IComplex
complex(IRational re, IRational im)
Create a symbolic complex numberstatic IAST
Complex(IExpr a0, IExpr a1)
Create aComplex(a, b)
AST symbolic expression.static IComplex
complexConvergent(double realPart, double imagPart)
Create a symbolic complex number.static IComplexNum
complexNum(double r)
Create a complex numeric number with imaginary part = 0.0static IComplexNum
complexNum(double r, double i)
Create a complex numeric valuestatic IComplexNum
complexNum(String realPart, String imaginaryPart, long precision)
Return aApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part.static IComplexNum
complexNum(org.apfloat.Apcomplex c)
Return aApcomplexNum
which wraps aApcomplex
arbitrary precision floating-point complex number.static IComplexNum
complexNum(org.apfloat.Apfloat realPart)
Return aApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part with imaginary part set to0
.static IComplexNum
complexNum(org.apfloat.Apfloat realPart, org.apfloat.Apfloat imaginaryPart)
Return aApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part.static IComplexNum
complexNum(org.hipparchus.complex.Complex c)
Return aComplexNum
which wraps aComplex
number with Java double values for the real and imaginary part.static IComplexNum
complexNum(IComplex value)
static IComplexNum
complexNum(IFraction value)
static IComplexNum
complexNum(IInteger value)
static IAST
CompoundExpression(IExpr... expr)
Evaluates its arguments in turn, returning the last result.static IAST
Condition(IExpr pattern, IExpr test)
Places an additional constraint onpattern
that only allows it to match iftest
evaluates toS.True
.static IAST
ConditionalExpression(IExpr expr, IExpr condition)
static IAST
Cone(IExpr matrix)
static IAST
Cone(IExpr matrix, IExpr radius)
static IAST
Conjugate(IExpr a0)
static IAST
ConjugateTranspose(IExpr a0)
static IASTAppendable
constantArray(IExpr value, int copies)
Create a newList()
withcopies
number of arguments, which are set tovalue
.static IASTAppendable
constantArray(IExpr head, IExpr value, int copies)
Create a new abstract syntax tree (AST) with ahead
andcopies
number of arguments, which are set tovalue
.static IAST
ConstantArray(IExpr a0, IExpr a1)
static IAST
Continue()
static IAST
ContinuedFraction(IExpr a0)
static IAST
CoordinateBoundingBox(IExpr a0)
static IAST
CoordinateBounds(IExpr a0)
static IAST
CoplanarPoints(IExpr a0)
static IAST
CoprimeQ(IExpr a0, IExpr a1)
static IAST
Cos(IExpr z)
Returns the cosine ofz
(measured in Radians).static IAST
Cosh(IExpr z)
static IAST
CoshIntegral(IExpr z)
static IAST
CosIntegral(IExpr z)
static IAST
Cot(IExpr z)
Returns the cotangent ofz
(measured in Radians).static IAST
Coth(IExpr z)
static IAST
Count(IExpr a0, IExpr a1)
static IAST
Count(IExpr a0, IExpr a1, IExpr a2)
static IAST
Covariance(IExpr a0, IExpr a1)
static IAST
Cross(IExpr a0, IExpr a1)
static IAST
Csc(IExpr z)
static IAST
Csch(IExpr z)
static IAST
cse(IExpr expr)
Perform "common subexpression elimination" (CSE) on an expression.static IAST
cse(IExpr expr, Supplier<String> variablePrefix)
Perform "common subexpression elimination" (CSE) on an expression.static void
cseAsJava(IExpr expr, StringBuilder buf)
Perform "common subexpression elimination" (CSE) on an expression and create Java source code in the givenStringBuilder
.static void
cseAsJava(IExpr expr, Supplier<String> variablePrefix, StringBuilder buf)
Perform "common subexpression elimination" (CSE) on an expression and create Java source code in the givenStringBuilder
.static IAST
Cube(IExpr center, IExpr length)
static IAST
CubeRoot(IExpr arg)
static IAST
Cuboid(IExpr pMin, IExpr pMax)
static IAST
Cycles(IExpr a0)
static IAST
Cylinder(IExpr matrix)
static IAST
Cylinder(IExpr matrix, IExpr radius)
static IAST
D()
static IAST
D(IExpr f, IExpr x)
static IAST
Dashing(IExpr a)
static IAST
Decrement(IExpr a)
static IAST
Defer(IExpr a0)
static IAST
Delete(IExpr a0, IExpr a1)
static IAST
DeleteCases(IExpr... a)
static IAST
Denominator(IExpr expr)
static IAST
Depth(IExpr a0)
static IAST
Derivative(IExpr... a)
static IAST
DesignMatrix(IExpr a0, IExpr a1, IExpr a2)
static IAST
Det(IExpr a0)
static IAST
DiagonalMatrix(IExpr a0)
static IAST
DiagonalMatrix(IExpr a0, IExpr a1)
static IAST
DiagonalMatrixQ(IExpr a0)
static IAST
DiagonalMatrixQ(IExpr a0, IExpr a1)
static IAST
DialogReturn()
static IAST
DialogReturn(IExpr a0)
static IAST
DigitQ(IExpr a0)
DigitQ(str)static IAST
Dimensions(IExpr a0)
Dimensions(expr)static IAST
DiracDelta(IExpr a0)
static IAST
DirectedEdge(IExpr a, IExpr b)
DirectedEdge
is a directed edge from vertexa
bstatic IAST
DirectedInfinity(IExpr a0)
static IASTMutable
DirectionalLight(IExpr color, IExpr point)
static IAST
DiscreteDelta(IExpr a)
static IAST
DiscreteUniformDistribution(IExpr a)
static IAST
Discriminant(IExpr a0, IExpr a1)
static IAST
Disk(IAST originList)
static IAST
Distribute(IExpr a)
static IAST
Distribute(IExpr a0, IExpr a1)
static IAST
Distribute(IExpr a0, IExpr a1, IExpr a2)
static IAST
Distributed(IExpr x, IAST distribution)
Create aDistributed(x, <distribution>)
AST.static IExpr
div(Integer i, IExpr b)
static IExpr
div(BigInteger i, IExpr b)
static IExpr
div(IExpr a, Integer i)
static IExpr
div(IExpr a, BigInteger i)
static IExpr
Divide(int numerator, IExpr denominator)
The divisionnumerator / denominator
will be represented bynumerator * denominator^(-1)
.static IExpr
Divide(IExpr numerator, int denominator)
The divisionnumerator / denominator
will be represented bynumerator * denominator^(-1)
.static IExpr
Divide(IExpr numerator, IExpr denominator)
The divisionnumerator / denominator
will be represented bynumerator * denominator^(-1)
.static IASTMutable
DivideSides(IExpr equationOrInequality)
static IASTMutable
DivideSides(IExpr equationOrInequality, IExpr a1)
static IAST
Divisible(IExpr a0, IExpr a1)
static IAST
Divisors(IExpr a0)
static IAST
DivisorSigma(IExpr a0, IExpr a1)
static IAST
Do(IExpr a0, IExpr a1)
static IAST
Dot(IExpr... a)
static IAST
Dot(IExpr a, IExpr b)
static IAST
Dot(IExpr a, IExpr b, IExpr c)
static IAST
Drop(IExpr list, IExpr a1)
static IAST
Drop(IExpr list, IExpr a1, IExpr a2)
static IAST
DSolve(IExpr a0, IExpr a1, IExpr a2)
static ISymbol
Dummy()
Create a unique dummy symbol with prefix "$", which is retrieved from the evaluation engines DUMMY context.static ISymbol
Dummy(char symbolName)
Create a unique dummy symbol which is retrieved from the evaluation engines DUMMY context.static ISymbol
Dummy(String symbolName)
Create a unique dummy symbol which is retrieved from the evaluation engines DUMMY context.static IAST
Eigensystem(IExpr m)
static IAST
Eigenvalues(IExpr m)
static IAST
Eigenvectors(IExpr m)
static IAST
Element(IExpr variable, IExpr domain)
Set a domain as an assumption for a variable.static IAST
ElementData(IExpr name, IExpr property)
Property of aname
chemical element.static IAST
Eliminate(IExpr a0, IExpr a1)
static IAST
EllipticE(IExpr m)
static IAST
EllipticE(IExpr phi, IExpr m)
static IAST
EllipticF(IExpr phi, IExpr m)
static IAST
EllipticK(IExpr m)
static IAST
EllipticPi(IExpr n, IExpr m)
static IAST
EllipticPi(IExpr n, IExpr phi, IExpr m)
static IAST
Equal(IExpr... a)
static IAST
Equal(IExpr lhs, int rhs)
static IAST
Equal(IExpr lhs, IExpr rhs)
static IAST
Equivalent(IExpr lhs, IExpr rhs)
static IAST
Erf(IExpr a)
static IAST
Erfc(IExpr a)
static IAST
Erfi(IExpr a)
static IAST
ErlangDistribution(IExpr a0, IExpr a1)
static IAST
EuclideanDistance(IExpr a0, IExpr a1)
static IAST
EulerE(IExpr n)
static IAST
EulerE(IExpr n, IExpr x)
static IAST
EulerPhi(IExpr a0)
static IExpr
eval(String str)
Parse and evaluate a string expression.static IExpr
eval(IExpr a)
Evaluate an expression.static IExpr
evalCollect(IExpr expr, IExpr x)
static IExpr
evalExpand(IExpr expr)
EvaluateExpand()
for the given expression.static IExpr
evalExpandAll(IExpr a)
ApplyExpandAll()
to the given expression if it's anIAST
.static IExpr
evalExpandAll(IExpr a, EvalEngine engine)
ApplyExpandAll()
to the given expression if it's anIAST
.static IExpr
evaln(IExpr a0)
Deprecated.useEvalEngine.evalN(IExpr)
insteadstatic IExpr
evalQuiet(IExpr a)
Deprecated.use EvalEngine#evalQuiet();static IExpr
evalQuietNull(IExpr a)
Deprecated.use EvalEngine#evalQuietNull()static IExpr
evalSimplify(IExpr expr)
static boolean
evalTrue(IExpr expr)
Deprecated.use EvalEngine#evalTrue()static IAST
EvenQ(IExpr x)
EvenQ(x)static IAST
ExactNumberQ(IExpr expr)
ExactNumberQ(expr)static IAST
Exists(IExpr a0, IExpr a1)
static IAST
Exists(IExpr a0, IExpr a1, IExpr a2)
static IAST
Exp(int z)
static IAST
Exp(IExpr z)
The exponential functionE^z
.static IExpr
expand(IExpr a, boolean expandNegativePowers, boolean distributePlus, boolean evalParts)
ApplyExpand()
to the given expression if it's anIAST
.static IAST
Expand(IExpr expr)
Expands out positive rational powers and products of sums inexpr
.static IAST
Expand(IExpr expr, IExpr pattern)
Expands out positive rational powers and products of sums inexpr
.static IExpr
expandAll(IExpr a, boolean expandNegativePowers, boolean distributePlus)
ApplyExpandAll()
to the given expression if it's anIAST
.static IAST
ExpandAll(IExpr a0)
static IAST
ExpIntegralE(IExpr a0, IExpr a1)
static IAST
ExpIntegralEi(IExpr a)
static IAST
Exponent(IExpr a0, IExpr a1)
static IAST
Exponent(IExpr a0, IExpr a1, IExpr a2)
static IAST
ExponentialDistribution(IExpr a0)
static IAST
ExportString(IExpr a0, IExpr a1)
static IReal
expr(Number number)
static IAST
ExpToTrig(IExpr a0)
static IAST
Extract(IExpr a0, IExpr a1)
static IAST
f1(IExpr... a)
static IAST
f2(IExpr... a)
static IAST
f3(IExpr... a)
static IAST
f4(IExpr... a)
static IAST
Factor(IExpr poly)
static IAST
Factorial(int a0)
static IAST
Factorial(IExpr a0)
static IAST
Factorial2(IExpr a0)
static IAST
FactorialPower(IExpr x, IExpr n)
static IAST
FactorialPower(IExpr x, IExpr n, IExpr h)
static IAST
FactorInteger(IExpr a0)
static IAST
FactorSquareFree(IExpr a)
static IAST
FactorSquareFreeList(IExpr a)
static IAST
FactorTerms(IExpr poly)
static IAST
Fibonacci(IExpr a0)
static IAST
Fibonacci(IExpr a0, IExpr a1)
static IAST
FindFit(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
FindMaximum(IExpr f, IExpr x)
static IAST
FindMinimum(IExpr f, IExpr x)
static IAST
FindRoot(IExpr f, IExpr x)
static IAST
FindShortestPath(IExpr a0, IExpr a1, IExpr a2)
static IAST
FindShortestTour(IExpr a0)
static IAST
FindSpanningTree(IExpr a0)
static IAST
First(IExpr a0)
static IAST
Fit(IExpr a0, IExpr a1, IExpr a2)
static IAST
FiveNum(IExpr a)
static IAST
Flatten(IExpr a0)
static IAST
Flatten(IExpr a0, IExpr a1)
static IAST
flattenSequence(IAST list)
Iterate over the arguments oflist
and flatten the arguments ofSequence(...)
expressions.static IAST
Floor(IExpr z)
static IAST
Fold(IExpr a0, IExpr a1, IExpr a2)
static IAST
ForAll(IExpr a0, IExpr a1)
static IAST
ForAll(IExpr a0, IExpr a1, IExpr a2)
static IFraction
fraction(double value)
Create a "fractional" number from a double number withConfig.DOUBLE_EPSILON
maximum error allowed.static IFraction
fraction(double value, double epsilon)
Create a "fractional" number from a double number.static IRational
fraction(long numerator, long denominator)
Create a "fractional" numberstatic IFraction
fraction(BigInteger numerator, BigInteger denominator)
Create a "fractional" numberstatic IFraction
fraction(org.hipparchus.fraction.BigFraction value)
Create a "fractional" numberstatic IFraction
fraction(IInteger numerator, IInteger denominator)
Create a "fractional" numberstatic IAST
FractionalPart(IExpr a)
static IAST
FractionBox(IExpr a0, IExpr a1)
static IFraction
fractionConvergent(double value)
Create a "fractional" number from a double number.static IExpr
fractionExact(double value, boolean attemptNiceFraction)
Create a "fractional" expression that exactly represents the given double number.static IAST
FrechetDistribution(IExpr a0, IExpr a1)
static IAST
FreeQ(IExpr expr, IExpr form)
static IAST
FresnelC(IExpr a)
static IAST
FresnelS(IExpr a)
static IAST
FromPolarCoordinates(IExpr a)
static IAST
FromSphericalCoordinates(IExpr a)
static IExpr
fromString(String string)
Parses a given string to an instance ofIExpr
static IAST
FullForm(IExpr a0)
static IAST
FullSimplify(IExpr a)
static IASTMutable
function(IExpr head, IExpr... a)
Create a new abstract syntax tree (AST).static IAST
Function(IExpr a0)
static IAST
Function(IExpr a0, IExpr a1)
static IAST
FunctionDomain(IExpr a0, IExpr a1)
static IAST
FunctionDomain(IExpr a0, IExpr a1, IExpr a2)
static IAST
FunctionExpand(IExpr a0)
static IAST
FunctionExpand(IExpr a0, IExpr a1)
static IAST
FunctionRange(IExpr a0, IExpr a1, IExpr a2)
static IAST
FunctionRange(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
FunctionURL(IExpr a0)
static IAST
Gamma(IExpr a0)
static IAST
Gamma(IExpr a0, IExpr a1)
static IAST
Gamma(IExpr a0, IExpr a1, IExpr a2)
static IAST
GammaDistribution(IExpr a0, IExpr a1)
static IAST
GammaDistribution(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
GammaRegularized(IExpr a0, IExpr a1)
static IAST
GammaRegularized(IExpr a0, IExpr a1, IExpr a2)
static IAST
Gather(IExpr a0, IExpr a1)
static IAST
GatherBy(IExpr a0, IExpr a1)
static IAST
GCD(IExpr a0)
static IAST
GCD(IExpr a0, IExpr a1)
static IAST
GegenbauerC(IExpr a0, IExpr a1)
static IAST
GegenbauerC(IExpr a0, IExpr a1, IExpr a2)
static IAST
GeoDistance(IExpr a0, IExpr a1)
static IAST
GeometricMean(IExpr a0)
static IAST
Get(String str)
static IAST
Get(IExpr a0)
static String
getPredefinedInternalFormString(String key)
static IPattern
getPredefinedPattern(String key)
static IPatternSequence
getPredefinedPatternSequence(String key)
static IExpr
getUnaryInverseFunction(IExpr symbol)
static IAST
Grad(IExpr a0, IExpr a1)
static IAST
Graph(IExpr a0)
static IAST
Graph(IExpr a0, IExpr a1)
static IAST
Graph(IExpr a0, IExpr a1, IExpr a2)
static IASTAppendable
Graphics()
static IASTAppendable
Graphics(IExpr graphicPrimitives)
static IASTAppendable
Graphics(IExpr graphicPrimitives, IAST... optionRules)
static IASTAppendable
Graphics3D(IExpr graphicPrimitives)
static IAST
Graphics3D(IExpr graphicPrimitives, IExpr option)
static IAST
Greater(IExpr x, int y)
static IAST
Greater(IExpr x, IExpr y)
static IAST
GreaterEqual(IExpr x, int y)
static IAST
GreaterEqual(IExpr x, IExpr y)
static IAST
Gudermannian(IExpr a0)
static IAST
GumbelDistribution()
static IAST
GumbelDistribution(IExpr a0, IExpr a1)
static IAST
HankelH1(IExpr a0, IExpr a1)
static IAST
HankelH2(IExpr a0, IExpr a1)
static IAST
HarmonicMean(IExpr a0)
static IAST
HarmonicNumber(IExpr a)
static IAST
HarmonicNumber(IExpr a0, IExpr a1)
static boolean
hasSymbol(String symbolName, EvalEngine engine)
Test if thesymbolName
is defined in the one of the contexts available on the context path.static IAST
Haversine(IExpr a)
static IAST
Head(IExpr a)
static IASTMutable
headAST0(IExpr head)
Create a new abstract syntax tree (AST).static IExpr
heaviside(IExpr a0, IExpr defaultValue, EvalEngine engine)
static IAST
HeavisideTheta(IExpr a0)
static IAST
HermiteH(IExpr a0, IExpr a1)
static IAST
HermitianMatrixQ(IExpr a0)
static IAST
HilbertMatrix(IExpr a0)
static IAST
Histogram(IExpr a)
static IAST
Hold(IExpr a0)
static IAST
HoldComplete(IExpr a0)
static IAST
HoldForm(IExpr a0)
static IAST
HoldPattern(IExpr a0)
static IAST
HurwitzLerchPhi(IExpr z, IExpr s, IExpr a)
static IAST
HurwitzZeta(IExpr a0, IExpr a1)
static IAST
Hyperfactorial(IExpr a0)
static IAST
Hypergeometric0F1(IExpr a0, IExpr a1)
static IAST
Hypergeometric1F1(IExpr a0, IExpr a1, IExpr a2)
static IAST
Hypergeometric1F1Regularized(IExpr a0, IExpr a1, IExpr a2)
static IAST
Hypergeometric2F1(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
Hypergeometric2F1Regularized(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
HypergeometricPFQ(IExpr a0, IExpr a1, IExpr a2)
static IAST
HypergeometricPFQRegularized(IExpr a0, IExpr a1, IExpr a2)
static IAST
HypergeometricU(IExpr a0, IExpr a1, IExpr a2)
static IAST
Identity(IExpr a0)
static IAST
IdentityMatrix(int dim)
static IAST
IdentityMatrix(IExpr a0)
static IAST
If(IExpr condition, IExpr trueExpr)
static IAST
If(IExpr condition, IExpr trueExpr, IExpr falseExpr)
static IAST
If(IExpr condition, IExpr trueExpr, IExpr falseExpr, IExpr undefinedExpr)
static IAST
IInit(ISymbol sym, int[] sizes)
static IExpr
IIntegrate(int priority, IAST lhs, IExpr rhs)
static IExpr
Im(IExpr a0)
static IAST
Implies(IExpr a0, IExpr a1)
static IAST
In(IExpr a0)
static IAST
Increment(IExpr a)
static IAST
Inequality(IExpr... a)
static IAST
InexactNumberQ(IExpr a)
InexactNumberQ(expr)static IAST
Information(IExpr a)
static IAST
Information(IExpr a0, IExpr a1)
static IPattern
initPredefinedPattern(ISymbol symbol)
static IPatternSequence
initPredefinedPatternSequence(ISymbol symbol)
static IPatternSequence
initPredefinedPatternSequence(ISymbol symbol, boolean zeroArgsAllowed)
static void
initSymbols()
Initialize the complete Systemstatic IAST
Insert(IExpr a0, IExpr a1, IExpr a2)
static IInteger
integer(long integerValue)
Deprecated.use ZZ()static IInteger
integer(String integerString, int radix)
Deprecated.use ZZ()static IInteger
integer(BigInteger integerValue)
Deprecated.use ZZ()static IAST
IntegerName(IExpr a0)
static IAST
IntegerName(IExpr a0, IExpr a1)
static IAST
IntegerPart(IExpr a0)
static IAST
IntegerQ(IExpr expr)
IntegerQ(expr)static IAST
Integrate(IExpr f, IExpr x)
Integratesf
with respect tox
.static IAST
InterpolatingPolynomial(IExpr a0, IExpr a1)
static IAST
Interpolation(IExpr list)
static IAST
InterquartileRange(IExpr a)
static IAST
Intersection(IExpr a0, IExpr a1)
static IAST
Interval(IExpr list)
Create an "interval" expression:Interval(list)
.static IAST
Interval(IExpr min, IExpr max)
Create an "interval" expression:Interval(List(from, to))
.static IASTAppendable
IntervalAlloc(int capacity)
Create a newList
with the givencapacity
.static IAST
IntervalComplement(IExpr a1, IExpr a2)
static IAST
IntervalData(IAST list)
Intervals will be represented by objects with headS.IntervalData
wrapped around a sequence of quadruples of the form, e.g.,{a,Less,LessEqual,b}
representing the half open interval(a,b]
.static IAST
IntervalData(IAST... lists)
Intervals will be represented by objects with headS.IntervalData
wrapped around a sequence of quadruples of the form, e.g.,{a,Less,LessEqual,b}
representing the half open interval(a,b]
.static IASTAppendable
IntervalDataAlloc(int capacity)
static IAST
IntervalIntersection(IExpr... intervals)
IntervalIntersection(interval_1, interval_2, ...) - compute the intersection of the intervals `interval_1, interval_2, ...`static IAST
IntervalMemberQ(IExpr interval, IExpr expr)
static IAST
IntervalUnion(IExpr... intervals)
IntervalUnion(interval_1, interval_2, ...) - compute the union of the intervals `interval_1, interval_2, ...`static IAST
intIterator(ISymbol head, Function<IExpr,IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code>.
static IAST
intIterator(ISymbol head, Function<IExpr,IExpr> function, IAST list)
static IAST
intIterator(ISymbol head, IntFunction<IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code>.
static IExpr
intProduct(Function<IInteger,IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code> and evaluate the
S.Product
static IExpr
intSum(Function<IInteger,IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code> and evaluate the
S.Sum
static IExpr
intSum(Function<IInteger,IExpr> function, int from, int to, int step, boolean expand)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code> and evaluate the
S.Sum
static IExpr
intSum(IntFunction<IExpr> function, int iMin, int iMax)
CalculateSum(function(k), {k, iMin, iMax})
static IAST
Inverse(IExpr a0)
static IAST
InverseBetaRegularized(IExpr a0, IExpr a1, IExpr a2)
static IAST
InverseBetaRegularized(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
InverseCDF(IExpr distribution, IExpr q)
static IAST
InverseErf(IExpr a0)
static IAST
InverseErfc(IExpr a0)
static IAST
InverseFunction(IExpr a)
static IAST
InverseGammaRegularized(IExpr a0, IExpr a1)
static IAST
InverseGammaRegularized(IExpr a0, IExpr a1, IExpr a2)
static IAST
InverseGudermannian(IExpr a0)
static IAST
InverseHaversine(IExpr a)
static IAST
InverseJacobiCD(IExpr a0, IExpr a1)
static IAST
InverseJacobiCN(IExpr a0, IExpr a1)
static IAST
InverseJacobiDC(IExpr a0, IExpr a1)
static IAST
InverseJacobiDN(IExpr a0, IExpr a1)
static IAST
InverseJacobiNC(IExpr a0, IExpr a1)
static IAST
InverseJacobiND(IExpr a0, IExpr a1)
static IAST
InverseJacobiSC(IExpr a0, IExpr a1)
static IAST
InverseJacobiSD(IExpr a0, IExpr a1)
static IAST
InverseJacobiSN(IExpr a0, IExpr a1)
static IAST
InverseLaplaceTransform(IExpr a0, IExpr a1, IExpr a2)
static IAST
InverseZTransform(IExpr expr, IExpr z, IExpr n)
static boolean
isAlmostSame(double a, double b)
static boolean
isEqual(double x, double y)
Check difference is less than a constantstatic boolean
isEqual(org.hipparchus.complex.Complex x, org.hipparchus.complex.Complex y)
static IAST
ISet(IExpr lhs, IExpr rhs)
Assign the evaluatedrhs
to thelhs
.
Note: this method returnsF.NIL
.static IAST
ISetDelayed(int priority, IExpr lhs, IExpr rhs)
static IAST
ISetDelayed(IExpr lhs, IExpr rhs)
Assign the unevaluatedrhs
to thelhs
.
Note: this method returnsNIL
.static boolean
isFuzzyEquals(double a, double b, double tolerance)
Returnstrue
ifa
andb
are withintolerance
(exclusive) of each other.static boolean
isFuzzyEquals(org.hipparchus.complex.Complex x, org.hipparchus.complex.Complex y, double tolerance)
static boolean
isNumEqualInteger(double value, IInteger ii)
static boolean
isNumEqualRational(double value, IRational rational)
Test ifrational.doubleValue()
equalsvalue
within the toleranceConfig.DOUBLE_TOLERANCE
.static boolean
isNumIntValue(double value)
Test if the value is a Javaint
value within the toleranceConfig.DOUBLE_TOLERANCE
.static boolean
isNumIntValue(double value, double epsilon)
Test if the value is a Javaint
value within the given toleranceepsilon
.static boolean
isNumIntValue(double value, int i)
static boolean
isSystemInitialized()
static boolean
isZero(double value)
Test if the absolute value is lessConfig.DOUBLE_EPSILON
.static boolean
isZero(double x, double epsilon)
Test if the absolute value is less than the given epsilon.static boolean
isZero(org.apfloat.Apcomplex x, double epsilon)
static boolean
isZero(org.apfloat.Apcomplex x, org.apfloat.Apfloat epsilon)
static boolean
isZero(org.apfloat.Apfloat x, double epsilon)
static boolean
isZero(org.apfloat.Apfloat x, org.apfloat.Apfloat epsilon)
static boolean
isZero(org.hipparchus.complex.Complex value)
Test if the absolute value is lessConfig.MACHINE_EPSILON
.static boolean
isZero(org.hipparchus.complex.Complex x, double epsilon)
Test if the absolute value is lessConfig.MACHINE_EPSILON
.static IAST
JacobiAmplitude(IExpr a0, IExpr a1)
static IAST
JacobiCD(IExpr a0, IExpr a1)
static IAST
JacobiCN(IExpr a0, IExpr a1)
static IAST
JacobiDC(IExpr a0, IExpr a1)
static IAST
JacobiDN(IExpr a0, IExpr a1)
static IAST
JacobiEpsilon(IExpr a0, IExpr a1)
static IAST
JacobiNC(IExpr a0, IExpr a1)
static IAST
JacobiND(IExpr a0, IExpr a1)
static IAST
JacobiP(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
JacobiSC(IExpr a0, IExpr a1)
static IAST
JacobiSD(IExpr a0, IExpr a1)
static IAST
JacobiSN(IExpr a0, IExpr a1)
static IAST
JavaForm(IExpr a0, IExpr a1)
static IAST
Join(IExpr a0, IExpr a1)
static IAST
JSFormData(String plainJavaScript, String format)
Create JavaScript form data in the given format.static IAST
KelvinBei(IExpr a0, IExpr a1)
static IAST
KelvinBer(IExpr a0, IExpr a1)
static IAST
Key(IExpr a0)
static IAST
KleinInvariantJ(IExpr a0)
static IAST
KroneckerDelta(IExpr a0)
static IAST
KroneckerDelta(IExpr a0, IExpr a1)
static IAST
LaguerreL(IExpr a0, IExpr a1)
static IAST
LaguerreL(IExpr a0, IExpr a1, IExpr a2)
static IAST
LaplaceTransform(IExpr a0, IExpr a1, IExpr a2)
static IAST
Last(IExpr a0)
static IAST
LCM(IExpr a0, IExpr a1)
static IAST
LeafCount(IExpr expr)
static IAST
LegendreP(IExpr a0, IExpr a1)
static IAST
LegendreP(IExpr a0, IExpr a1, IExpr a2)
static IAST
LegendreQ(IExpr a0, IExpr a1)
static IAST
LegendreQ(IExpr a0, IExpr a1, IExpr a2)
static IAST
Length(IExpr expr)
static IAST
LerchPhi(IExpr z, IExpr s, IExpr a)
static IAST
Less(IExpr x, int y)
static IAST
Less(IExpr x, IExpr y)
static IAST
Less(IExpr x1, IExpr x2, IExpr x3)
static IAST
Less(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
Less(IExpr a0, IExpr a1, IExpr a2, IExpr a3, IExpr a4)
static IAST
LessEqual(IExpr x, int y)
static IAST
LessEqual(IExpr x, IExpr y)
static IAST
LessEqual(IExpr x1, IExpr x2, IExpr x3)
static IAST
LessEqual(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
LeviCivitaTensor(IExpr d)
static IAST
Limit(IExpr f, IExpr rule)
static IAST
Limit(IExpr f, IExpr rule, IExpr direction)
static IASTAppendable
Line()
static IAST
Line(IExpr listOfPoints)
static IAST
LinearModelFit(IExpr a0)
static IAST
LinearModelFit(IExpr a0, IExpr a1)
static IAST
LinearModelFit(IExpr a0, IExpr a1, IExpr a2)
static IAST
LinearModelFit(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
LinearProgramming(IExpr a0, IExpr a1, IExpr a2)
static IAST
LinearSolve(IExpr a0, IExpr a1)
static IAST
list(IExpr expr)
Return a single value as aList()
static IAST
list(IExpr x1, IExpr x2)
Return a pair of values as aList()
static IAST
list(IExpr x1, IExpr x2, IExpr x3)
Return a triple of values as aList()
static IAST
List()
Create an empty immutable list{ }
(i.e.static IASTMutable
List(double... numbers)
static IASTMutable
List(int... numbers)
static IAST
List(long... numbers)
static IASTMutable
List(String... strs)
static IAST
List(IExpr... a)
Create an immutable list{ }
.static IASTAppendable
ListAlloc()
Create an appendable list{ }
.static IASTAppendable
ListAlloc(int initialCapacity)
Create a newList
with the giveninitial capacity
.static IASTAppendable
ListAlloc(Collection<? extends IExpr> collection)
Create a newList
with the capacitycollection.size()
and append the elements of the collection.static IASTAppendable
ListAlloc(Collection<? extends IExpr> collection, int capacity)
Create a newList
with the capacitycollection.size() + capacity
and append the elements of the collection.static IASTAppendable
ListAlloc(IntStream stream)
static IASTAppendable
ListAlloc(Stream<? extends IExpr> stream)
Constructs a list that holds the expressions of the input stream.static IASTAppendable
ListAlloc(IExpr... a)
Create an appendable list{ }
.static IAST
ListConvolve(IExpr a0, IExpr a1)
static IAST
listOfObjects(Object... objects)
static IAST
ListPlot(IExpr a)
static IAST
ListPlot3D(IExpr a)
static IAST
ListPointPlot3D(IExpr a)
static IAST
ListQ(IExpr a)
ListQ(expr)static IAST
Literal(IExpr a0)
Deprecated.use HoldPatternstatic IBuiltInSymbol
localBiFunction(String symbolName, BinaryOperator<IExpr> function)
static IBuiltInSymbol
localBiPredicate(String symbolName, BiPredicate<IExpr,IExpr> function)
static IBuiltInSymbol
localFunction(String symbolName, UnaryOperator<IExpr> function)
static IBuiltInSymbol
localFunction(String symbolName, IEvaluator evaluator)
static IBuiltInSymbol
localPredicate(String symbolName, Predicate<IExpr> function)
static IAST
Log(int z)
Returns the natural logarithm ofz
.static IAST
Log(int z, int base)
Returns the logarithm ofz
for thebase
.static IAST
Log(IExpr z)
Returns the natural logarithm ofz
.static IAST
Log(IExpr z, int base)
Returns the logarithm ofz
for thebase
.static IAST
Log(IExpr z, IExpr base)
Returns the logarithm ofz
for thebase
.static IAST
Log10(IExpr a0)
Log[10, a0]
.static IAST
LogGamma(IExpr a0)
static IAST
LogIntegral(IExpr a)
static IAST
LogisticSigmoid(IExpr a)
static IAST
LogNormalDistribution(IExpr a0, IExpr a1)
static IAST
LucasL(IExpr a)
static IAST
LucasL(IExpr a, IExpr b)
static IAST
MachineNumberQ(IExpr a0)
MachineNumberQ(expr)static IAST
Manipulate(IExpr a0)
static IAST
Manipulate(IExpr a0, IExpr a1)
static IAST
Map(IExpr f)
static IAST
Map(IExpr f, IExpr expr)
static IAST
Map(IExpr f, IExpr expr, IExpr levelspec)
static IAST
MapAll(IExpr a0)
static <T> IASTAppendable
mapFunction(IExpr head, List<T> list, Function<T,IExpr> function)
Iterates over the lists elements and calls the function.static <T> IASTAppendable
mapFunction(IExpr head, List<T> list, Function<T,IExpr> function, Predicate<T> predicate)
static IASTAppendable
mapFunction(IExpr head, IAST ast)
static <T extends IExpr>
IASTAppendablemapFunction(IExpr head, IAST ast, int start, int end, Function<T,IExpr> function)
static <T extends IExpr>
IASTAppendablemapFunction(IExpr head, IAST ast, int start, int end, Function<T,IExpr> function, Predicate<T> predicate)
static <T extends IExpr>
IASTAppendablemapFunction(IExpr head, IAST ast, Function<T,IExpr> function)
Iterates over theast
elements and calls the function.static <T extends IExpr>
IASTAppendablemapFunction(IExpr head, IAST ast, Function<T,IExpr> function, Predicate<T> predicate)
static IASTAppendable
mapFunction(IExpr head, IAST ast, ObjIntFunction<IExpr,IExpr> function)
Iterates over the lists elements and calls the function.static IASTAppendable
mapList(List<IExpr> list, Function<IExpr,IExpr> function, Predicate<IExpr> predicate)
static <T extends IExpr>
IASTAppendablemapList(List<T> list, Function<T,IExpr> function)
Iterates over the lists elements and calls the function.static <T extends IExpr>
IASTAppendablemapList(IAST ast, Function<T,IExpr> function)
Iterates over the lists elements and calls the function.static <T extends IExpr>
IASTAppendablemapList(IAST ast, Function<T,IExpr> function, Predicate<T> predicate)
static IASTAppendable
mapList(IAST ast, ObjIntFunction<IExpr,IExpr> function)
Iterates over the lists elements and calls the function.static IASTAppendable
mapMap(Map<? extends IExpr,? extends IExpr> map, BiFunction<IExpr,IExpr,IExpr> biFunction)
Iterates over the maps (key, value) pairs and calls the function.static <T extends IExpr>
IASTAppendablemapRange(int iMin, int iMax, IntFunction<T> function)
Create an integer range betweeniMin
(inclusive) andiMax
(exclusive) and call the function with the elements of the created range.static <T extends IExpr>
IASTAppendablemapRange(IExpr head, int iMin, int iMax, IntFunction<T> function)
Create an integer range betweeniMin
(inclusive) andiMax
(exclusive) and call the function with the elements of the created range.static IASTAppendable
mapSet(Set<? extends IExpr> exprSet, Function<IExpr,IExpr> function)
Iterates over the set elements and calls the function.static IAST
MapThread(IExpr f, IExpr expr)
static IAST
MatchQ(IExpr expr, IExpr form)
static IAST
MathMLForm(IExpr expr)
static IAST
Matrices(IExpr a0)
static IAST
Matrices(IExpr a0, IExpr a1)
static IAST
Matrices(IExpr a0, IExpr a1, IExpr a2)
static IAST
matrix(BiIntFunction<? extends IExpr> biFunction, int n, int m)
Generate an x m
matrix.static IAST
MatrixD(IExpr expr, IExpr x)
static IAST
MatrixExp(IExpr a0)
static IAST
MatrixForm(IExpr a0)
static IAST
MatrixLog(IExpr a0)
static IAST
MatrixPower(IExpr matrix, IExpr n)
static IASTAppendable
Max()
static IAST
Max(IExpr a0)
static IAST
Max(IExpr a0, IExpr a1)
static IAST
Max(IExpr a0, IExpr a1, IExpr a2)
static IAST
Max(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
Maximize(IExpr a0, IExpr a1)
static IAST
Mean(IExpr list)
static IAST
MeanDeviation(IExpr list)
static IAST
Median(IExpr list)
static IAST
MeijerG(IExpr a0, IExpr a1, IExpr a2)
static IAST
MemberQ(IExpr list, IExpr form)
static IAST
MessageName(IExpr a0, IExpr a1)
static IAST
MessageName(ISymbol symbol, String str)
static IASTAppendable
Min()
static IAST
Min(IExpr a0)
static IAST
Min(IExpr a0, IExpr a1)
static IAST
Min(IExpr a0, IExpr a1, IExpr a2)
static IAST
Min(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
Minimize(IExpr a0, IExpr a1)
static IExpr
minus(Integer i, IExpr b)
static IExpr
minus(BigInteger i, IExpr b)
static IExpr
minus(IExpr a, Integer i)
static IExpr
minus(IExpr a, BigInteger i)
static IAST
Missing(String reason)
static IAST
Missing(IExpr reason)
static IAST
Missing(IExpr a0, IExpr a1)
static IAST
MissingQ(IExpr a0)
MissingQ(expr)static IExpr
mod(Integer i, IExpr b)
static IExpr
mod(BigInteger i, IExpr b)
static IExpr
mod(IExpr a, Integer i)
static IExpr
mod(IExpr a, BigInteger i)
static IExpr
Mod(IExpr a0, IExpr a1)
static IAST
Module(IExpr listOfLocalVariables, IExpr expr)
Evaluatesexpr
for thelistOfLocalVariables
by first renaming the local variables inexpr
.static IAST
MoebiusMu(IExpr a0)
static IAST
Most(IExpr a0)
static IAST
Multinomial(IExpr... a)
static IAST
MultiplicativeOrder(IExpr a0, IExpr a1)
static IExpr
multiply(Integer i, IExpr b)
static IExpr
multiply(BigInteger i, IExpr b)
static IExpr
multiply(IExpr a, Integer i)
static IExpr
multiply(IExpr a, BigInteger i)
static IASTMutable
MultiplySides(IExpr equationOrInequality, IExpr x)
static IAST
N(IExpr symbolicExpr)
Evaluate the given (symbolic) expression in numeric mode.static IAST
N(IExpr symbolicExpr, IExpr precision)
Evaluate the given (symbolic) expression in numeric mode withprecision
digits .static IAST
NakagamiDistribution(IExpr a0, IExpr a1)
static IAST
NameQ(String str)
static IAST
NameQ(IExpr a0)
static IAST
Needs(IExpr a0)
static IExpr
Negate(IExpr x)
Multiplies the given argument by-1
.static IAST
Negative(IExpr x)
static IAST
Nest(IExpr a0, IExpr a1, int n)
static IAST
Nest(IExpr a0, IExpr a1, IExpr a2)
static IAST
newInstance(int intialArgumentsCapacity, IExpr head)
Create a new abstract syntax tree (AST).static IAST
NewLimit(IExpr f, IExpr rule)
static IAST
NewLimit(IExpr f, IExpr rule, IExpr direction)
static IAST
NMaximize(IExpr a0, IExpr a1)
static IAST
NMinimize(IExpr a0, IExpr a1)
static IAST
NonCommutativeMultiply(IExpr... a)
static IAST
Norm(IExpr a)
static IAST
NormalDistribution()
static IAST
NormalDistribution(IExpr a0, IExpr a1)
static IAST
Normalize(IExpr a)
static IAST
Not(IExpr expr)
Logical Not function (negation).static IAST
NotElement(IExpr x, IExpr domain)
static IAST
NRoots(IExpr a0, IExpr a1)
static IAST
NullSpace(IExpr a0)
static Num
num(double value)
Return aNum
which wraps a Java double number.static INum
num(String valueString)
Create a numeric value from the input string.static INum
num(String numberStr, long precision)
Return aApfloatNum
which wraps aApfloat
arbitrary precision floating-point number.static INum
num(org.apfloat.Apfloat af)
Return aApfloatNum
which wraps aApfloat
arbitrary precision floating-point number.static INum
num(IFraction value)
static INum
num(IInteger value)
static IAST
NumberQ(IExpr a0)
NumberQ(expr)static IAST
Numerator(IExpr expr)
static IAST
NumericalOrder(IExpr a0, IExpr a1)
static IAST
NumericalSort(IExpr a0)
static IAST
NumericQ(IExpr a0)
NumericQ(expr)static IAST
O(IExpr a0)
static IAST
OddQ(IExpr x)
OddQ(x)static IAST
On(IExpr a0)
static IAST
On(IExpr a0, IExpr a1)
static String
openHTMLOnDesktop(String html)
static IAST
operatorForm1Append(IAST ast1)
The operator formop(f)[expr]
is transformed toop(expr, f)
.static IAST
operatorForm2Prepend(IAST ast1, int[] expected, EvalEngine engine)
The operator formop(f)[expr]
is transformed toop(f, expr)
.static IAST
operatorFormAppend2(IAST astArg)
The binary operator formop(f, g)[expr]
is transformed toop(expr, f, g)
static IAST
OptimizeExpression(IExpr a0)
static IAST
Optional(IExpr a0)
static IAST
Optional(IExpr a0, IExpr a1)
static IAST
Options(IExpr a0)
static IAST
OptionValue(IExpr a0)
static IAST
OptionValue(IExpr a0, IExpr a1)
static IASTAppendable
Or()
static IAST
Or(IExpr... expr)
static IAST
Or(IExpr expr1, IExpr expr2)
static IAST
Or(IExpr expr1, IExpr expr2, IExpr expr3)
static IAST
Order(IExpr a0, IExpr a1)
static IAST
OrderedQ(IExpr a)
static IAST
Ordering(IExpr a)
static IAST
Out(int n)
static IAST
Out(IExpr a0)
static IAST
Overflow()
static Pair
pair(IExpr x1, IExpr x2)
Return a pair of values as aList()
static IAST
Parenthesis(IExpr a0)
static IAST
ParetoDistribution(IExpr a0, IExpr a1)
static IAST
ParetoDistribution(IExpr a0, IExpr a1, IExpr a2)
static IAST
ParetoDistribution(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IASTAppendable
Part()
See: Partstatic IASTAppendable
Part(int extraSize, IExpr... a)
See: Partstatic IASTAppendable
Part(IExpr... a)
See: Partstatic IAST
Part(IExpr expr, IExpr i)
Returns parti
ofexpr
.static IAST
Part(IExpr expr, IExpr i, IExpr j)
Returns the parti, j
ofexpr
.static IAST
PartitionsP(IExpr a0)
static IAST
PartitionsQ(IExpr a0)
static IPattern
pattern(ISymbol symbol)
Create a pattern for pattern-matching and term rewritingstatic IPattern
pattern(ISymbol symbol, IExpr check, boolean def)
Create a pattern for pattern-matching and term rewritingstatic IAST
PatternTest(IExpr pattern, IExpr test)
static IAST
PDF(IExpr distribution)
See: PDFstatic IAST
PDF(IExpr distribution, IExpr x)
See: PDFstatic IAST
Piecewise(IExpr listOfConditions)
See: Piecewisestatic IAST
Piecewise(IExpr listOfConditions, IExpr defaultValue)
See: Piecewisestatic IAST
PiecewiseExpand(IExpr expr)
See: PiecewiseExpandstatic IAST
Plot(IExpr a0, IExpr a1)
static IAST
Plot(IExpr a0, IExpr a1, IExpr a2)
static IAST
Plot3D(IExpr a0, IExpr a1, IExpr a2)
static IExpr
plus(Integer i, IExpr b)
static IExpr
plus(BigInteger i, IExpr b)
static IExpr
plus(IExpr a, Integer i)
static IExpr
plus(IExpr a, BigInteger i)
static IASTAppendable
Plus()
See: Plusstatic IAST
Plus(long num, IExpr... a)
Define aPlus()
expressionnum + a0 + a1 + a2 ...
for addition.static IASTAppendable
Plus(IExpr a0)
See: Plusstatic IAST
Plus(IExpr... a)
Define aPlus()
expressiona0 + a1 + a2 ...
for addition.static IAST
Plus(IExpr x, IExpr y)
Define aPlus()
expressionx + y
for addition.static IAST
Plus(IExpr x, IExpr y, IExpr z)
Define aPlus()
expressionx + y + z
for addition.static IASTAppendable
PlusAlloc(int initialCapacity)
See: Plusstatic IAST
PlusMinus(IExpr... a)
static IAST
Pochhammer(IExpr a0, IExpr a1)
static IAST
Point(IAST list)
static IAST
PointSize(double value)
static IAST
PointSize(IExpr a0)
static IAST
PoissonDistribution(IExpr a0)
static IAST
PolyGamma(int n, IExpr z)
static IAST
PolyGamma(IExpr a0)
static IAST
PolyGamma(IExpr a0, IExpr a1)
static IAST
Polygon(IExpr a0)
static IAST
PolyLog(IExpr a0, IExpr a1)
static IAST
PolyLog(IExpr n, IExpr p, IExpr z)
static IAST
PolynomialGCD(IExpr poly1, IExpr poly2)
static IAST
PolynomialQ(IExpr expr, IExpr variable)
static IAST
PolynomialQuotient(IExpr poly1, IExpr poly2, IExpr x)
static IAST
PolynomialQuotientRemainder(IExpr poly1, IExpr poly2, IExpr x)
static IAST
PolynomialRemainder(IExpr poly1, IExpr poly2, IExpr x)
static IAST
Position(IExpr a0, IExpr a1)
static IAST
Positive(IExpr a0)
static IAST
PossibleZeroQ(IExpr a0)
static IExpr
Power(IExpr base, long exponent)
Define a power expressionbase ^ exponent
.static IAST
Power(IExpr base, IExpr exponent)
Definebase
to the power ofexponent
.static IAST
PowerExpand(IExpr a0)
static IAST
PowerMod(IExpr a0, IExpr a1, IExpr a2)
static ISymbol
predefinedSymbol(String symbolName)
Create a "predefined" symbol for constants or function names.static IAST
Prepend(IExpr a0, IExpr a1)
static IAST
PrimeOmega(IExpr a0)
static IAST
PrimePi(IExpr a0)
See PrimePistatic IAST
PrimeQ(IExpr a0)
See PrimeQstatic IAST
Print(IExpr... a)
static IExpr
product(Function<IInteger,IExpr> function, int from, int to)
Iterate over an integer rangefrom <= i <= to
and create a product of the created values.static IAST
Product(IExpr expr, IExpr iterationSpecification)
static IAST
ProductLog(IExpr a0)
static IAST
ProductLog(IExpr a0, IExpr a1)
static IRational
productRational(IntFunction<IRational> function, int from, int to, int step)
static IAST
PseudoInverse(IExpr a0)
static IFraction
QQ(long numerator, long denominator)
Create a "fractional" numbernumerator / denominator
static IFraction
QQ(org.hipparchus.fraction.BigFraction frac)
Create a "fractional" number from a HipparchusBigFraction
number.static IFraction
QQ(IInteger numerator, IInteger denominator)
Create a "fractional" numbernumerator / denominator
static IAST
QRDecomposition(IExpr a0)
static IAST
Quantile(IExpr distribution)
Returns the Quantile of thedistribution
.static IAST
Quantile(IExpr list, IExpr q)
Returns theq
-Quantile oflist
.static IAST
Quantile(IExpr list, IExpr q, IExpr definition)
Returns theq
-Quantile oflist
with the given quantiledefinition
.static IAST
Quantity(IExpr magnitude, IExpr unit)
Returns the quantity formagnitude
andunit
.static IAST
QuantityMagnitude(IExpr quantity)
Returns the value of thequantity
.static IAST
QuantityMagnitude(IExpr quantity, IExpr unit)
Returns the value of thequantity
for the givenunit
static IAST
Quartiles(IExpr a0)
static IASTAppendable
quaternary(IExpr head, IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
Quiet(IExpr a0)
static IASTMutable
quinary(IExpr head, IExpr a0, IExpr a1, IExpr a2, IExpr a3, IExpr a4)
static IAST
Quotient(IExpr a0, IExpr a1)
static IAST
Quotient(IExpr a0, IExpr a1, IExpr a2)
static IAST
RandomComplex(IExpr a0)
static IAST
RandomInteger(IExpr a0)
static IAST
RandomReal(IExpr a0)
static IAST
RandomVariate(IExpr a0)
static IAST
RandomVariate(IExpr a0, IExpr a1)
static IAST
Range(IExpr a0)
static IAST
Range(IExpr a0, IExpr a1)
static IAST
Range(IExpr a0, IExpr a1, IExpr a2)
static IAST
Rational(IExpr a0, IExpr a1)
static IAST
Rationalize(IExpr a0)
static IAST
Rationalize(IExpr a0, IExpr a1)
static IExpr
Re(IExpr a0)
static IAST
RealAbs(IExpr a)
static IAST
RealSign(IExpr a)
static IAST
RealValuedNumberQ(IExpr a)
static IAST
RealValuedNumericQ(IExpr a)
static IAST
Reap(IExpr a)
static IAST
Rectangle(IAST originList)
static IExpr
reduce(IAST ast, int startInclusive, int endExclusive, IExpr identity, BinaryOperator<IExpr> accumulator)
Performs a reduction on the elements of this function range, using the provided identity value and an associative accumulation function, and returns the reduced value.static IAST
Reduce(IExpr logicExpr, IExpr variable)
Reduce(logic-expression, var) - returns the reduced `logic-expression` for the variable `var`.static IAST
Refine(IExpr a)
static IAST
Refine(IExpr a0, IExpr a1)
static IAST
RegularExpression(String str)
static IAST
RegularExpression(IExpr a0)
static double
relativeDifference(double x, double y)
Calculate the relative difference between x and y.static IAST
ReleaseHold(IExpr z)
static ISymbol
removeUserSymbol(String symbolName)
Remove a user-defined symbol from the eval engines context path.static IAST
Replace(IExpr a0, IExpr a1)
static IAST
ReplaceAll(IExpr a0, IExpr a1)
static IAST
ReplaceList(IExpr a0, IExpr a1)
static IAST
ReplacePart(IExpr a0, IExpr a1)
static IAST
ReplacePart(IExpr a0, IExpr a1, IExpr a2)
static IAST
ReplaceRepeated(IExpr a0, IExpr a1)
static IAST
Rest(IExpr a0)
static IAST
Resultant(IExpr a0, IExpr a1, IExpr a2)
static IAST
Return(IExpr a)
static IAST
Reverse(IExpr a)
static IAST
RGBColor(double red, double green, double blue)
static IAST
RGBColor(IExpr red, IExpr green, IExpr blue)
static IAST
RomanNumeral(IExpr a)
static IAST
Root(IExpr function, int k)
static IAST
Root(IExpr function, IExpr k)
static IAST
Roots(IExpr a0)
static IAST
Roots(IExpr a0, IExpr a1)
static IAST
RotationTransform(IExpr x)
static IAST
Round(IExpr x)
static IAST
RowBox(IAST list)
static IAST
RowReduce(IExpr m)
static IAST
Rule(String lhsStr, String rhsStr)
Represents a rule replacinglhsStr
withrhsStr
.static IAST
Rule(String lhsStr, IExpr rhs)
Represents a rule replacinglhsStr
withrhs
.static IAST
Rule(IExpr lhs, String rhsStr)
Represents a rule replacinglhs
withrhsStr
.static IAST
Rule(IExpr lhs, IExpr rhs)
Represents a rule replacinglhs
withrhs
.static IAST
RuleDelayed(IExpr lhs, IExpr rhs)
Represents a rule replacinglhs
withrhs
, withrhs
held unevaluated.static IAST
SameQ(IExpr a0, double d)
static IAST
SameQ(IExpr lhs, IExpr rhs)
static IAST
SatisfiabilityInstances(IExpr a0, IExpr a1, IExpr a2)
static IAST
ScalingTransform(IExpr z)
static IAST
Scan(IExpr a0, IExpr a1)
static IAST
Sec(IExpr z)
static IAST
Sech(IExpr z)
static IAST
Select(IExpr a0, IExpr a1)
static IAST
Select(IExpr a0, IExpr a1, IExpr a2)
static IAST
senary(IExpr head, IExpr a0, IExpr a1, IExpr a2, IExpr a3, IExpr a4, IExpr a5)
static IASTAppendable
Sequence()
static IASTMutable
Sequence(int... numbers)
static IAST
Sequence(IExpr a0)
static IAST
Sequence(IExpr... a)
static IAST
Series(IExpr... a)
static IAST
SeriesCoefficient(IExpr a0, IExpr a1)
static IAST
SeriesData(IExpr... a)
static IAST
Set(IExpr lhs, IExpr rhs)
Evaluatesrhs
and assigns it tolhs
.static IAST
SetAttributes(IExpr symbol, IExpr attribute)
static IAST
SetDelayed(IExpr lhs, IExpr rhs)
Assignsrhs
tolhs
, without evaluatingrhs
.static IAST
ShearingTransform(IExpr a0, IExpr a1, IExpr a2)
static String
show(IExpr expr)
Show the result in an HTML page with the help of the JavaDesktop.getDesktop().open()
method.static IAST
Show(IExpr a0)
static String
showGraphic(IExpr expr)
static IAST
Sign(IExpr z)
static IAST
Signature(IExpr a)
static IAST
SignCmp(IExpr z)
static IAST
Simplify(IExpr expr)
static IAST
Simplify(IExpr expr, IExpr assum)
static IAST
Sin(IExpr z)
Returns the sine ofz
(measured in Radians).static IAST
Sinc(IExpr z)
static IAST
Sinh(IExpr z)
static IAST
SinhIntegral(IExpr z)
static IAST
SinIntegral(IExpr z)
static IAST
Skewness(IExpr a0)
static IAST
Slot(int i)
static IAST
Slot(String str)
static IAST
Slot(IExpr a0)
static IAST
SlotSequence(int i)
static IExpr[]
solve(IAST equations, ISymbol variable)
Solve an equation for a single variable.static IAST
Solve(IExpr a0, IExpr a1)
See Solvestatic IAST
Solve(IExpr a0, IExpr a1, IAST options)
static IAST
Sort(IExpr a0)
static IAST
Sort(IExpr a0, IExpr a1)
static IAST
Sow(IExpr a)
static IAST
Span(IExpr... a)
static ISparseArray
sparseArray(IAST arrayRulesList)
Create a sparse array from the list of rules.static ISparseArray
sparseArray(IAST arrayRulesList, int[] dimension)
Create a sparse array in the givendimension
from the list of rules.static ISparseArray
sparseArray(IAST denseList, IExpr defaultValue)
Create a sparse array from the dense list representation (for example dense vectors and matrices)static ISparseArray
sparseMatrix(BiIntFunction<? extends IExpr> binaryFunction, int n, int m)
Generate an x m
sparse matrix.static IAST
Sphere(IExpr vector, IExpr radius)
static IAST
SphericalBesselJ(IExpr n, IExpr z)
static IAST
SphericalBesselY(IExpr n, IExpr z)
static IAST
SphericalHankelH1(IExpr n, IExpr z)
static IAST
SphericalHankelH2(IExpr n, IExpr z)
static IAST
SphericalHarmonicY(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
static IAST
Sqr(IExpr x)
Create a "square" expression:Power(x, 2)
.static IAST
Sqrt(int n)
Create a "square root" expression:Power(n, 1/2)
.static IAST
Sqrt(IExpr x)
Create a "square root" expression:Power(x, 1/2)
.static IAST
StandardDeviation(IExpr a0)
static IAST
Standardize(IExpr a0)
static IAST
Standardize(IExpr a0, IExpr a1)
static IAST
Standardize(IExpr a0, IExpr a1, IExpr a2)
static IAST
StieltjesGamma(IExpr a0)
static IAST
StieltjesGamma(IExpr a0, IExpr a1)
static IAST
StirlingS1(IExpr n, IExpr m)
static IAST
StirlingS2(IExpr n, IExpr m)
static IAST
StringJoin(IExpr a)
static IStringX
stringx(char c)
Create a Symja string expression with mime type TEXT_PLAIN.static IStringX
stringx(String str)
Create a Symja string expression with mime type TEXT_PLAIN.static IStringX
stringx(StringBuilder str)
Create a string expressionstatic IStringX
stringx(String str, short mimeType)
reate a Symja string expression.static IAST
StruveH(IExpr a0, IExpr a1)
static IAST
StruveL(IExpr a0, IExpr a1)
static IAST
StudentTDistribution(IExpr a0)
static IAST
StudentTDistribution(IExpr a0, IExpr a1, IExpr a2)
static IAST
Style(IExpr a0, IExpr a1)
static ASTRealVector
subdivide(double xMin, double xMax, int n)
Create a list by dividing the rangexMin
toxMax
inton
parts.static ASTRealVector
subdivide(double xMax, int n)
Create a list by dividing the range0
toxMax
inton
parts.static IAST
subdivide(int n)
Create a list{0, 1/n,2/n,3/n,...,n}
.static IAST
subdivide(int xMax, int n)
Create a list by dividing the range0
toxMax
inton
parts.static IAST
subdivide(int xMin, int xMax, int n)
Create a list by dividing the rangexMin
toxMax
inton
parts.static IAST
Subdivide(IExpr a0)
static IAST
Subdivide(IExpr a0, IExpr a1)
static IAST
Subdivide(IExpr a0, IExpr a1, IExpr a2)
static IAST
Subfactorial(IExpr a0)
static IExpr
subs(IExpr expr, IExpr x, IExpr y)
Substitute all (sub-) expressionsx
inexpr
withy
.static IAST
Subscript(IExpr x, IExpr y)
static IExpr
subsList(IExpr expr, Map<? extends IExpr,? extends IExpr> map)
Substitute all (sub-) expressions contained as keys inmap
inexpr
with the corresponding value inmap
.static IExpr
subst(IExpr expr, Function<IExpr,IExpr> function)
Substitute all (sub-) expressions with the given unary function.static IExpr
subst(IExpr expr, Map<? extends IExpr,? extends IExpr> map)
Substitute all (sub-) expressions with the given map.static IExpr
subst(IExpr expr, IAST astRules)
Substitute all (sub-) expressions with the given rule set.static IExpr
subst(IExpr expr, IExpr subExpr, IExpr replacementExpr)
Substitute all (sub-) expressions with the given replacement expression.static IAST
Subtract(IExpr x, int y)
Returnx + (-1)*y
static IAST
Subtract(IExpr x, IExpr y)
Returnx + (-1)*y
static IASTMutable
SubtractSides(IExpr equationOrInequality)
static IASTMutable
SubtractSides(IExpr equationOrInequality, IExpr x)
static IExpr
sum(Function<IInteger,IExpr> function, int iMin, int iMax)
Evaluate the sum fromiMin
toiMax
and step1
.static IExpr
sum(Function<IInteger,IExpr> function, int iMin, int iMax, int iStep)
Evaluate the sum fromiMin
toiMax
and stepiStep
.static IExpr
sum(Function<IInteger,IExpr> function, int iMin, int iMax, int iStep, boolean expand)
Evaluate the sum fromiMin
toiMax
and stepiStep
.static IAST
Sum(IExpr expr, IExpr iterationSpecification)
static IAST
Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2)
static IAST
Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2, IExpr iterationSpecification3)
static IAST
Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2, IExpr iterationSpecification3, IExpr iterationSpecification4)
static IAST
Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2, IExpr iterationSpecification3, IExpr iterationSpecification4, IExpr iterationSpecification5)
static IRational
sumRational(IntFunction<IRational> function, int iMin, int iMax)
static IRational
sumRational(IntFunction<IRational> function, int from, int to, int step)
static IAST
Superscript(IExpr x, IExpr y)
static IAST
Surd(IExpr a0, IExpr a1)
static IASTAppendable
SurfaceGraphics()
static IAST
Switch(IExpr... a)
static ISymbol
symbol(String symbolName)
Get or create a user defined symbol which is retrieved from the evaluation engines context path.static ISymbol
symbol(String symbolName, String contextStr, IAST assumptionAST, EvalEngine engine)
static ISymbol
symbol(String symbolName, EvalEngine engine)
Get or create a user defined symbol which is retrieved from the evaluation engines context path.static ISymbol
symbol(String symbolName, IAST assumptionAST)
Get or create a user defined symbol which is retrieved from the evaluation engines context path.static ISymbol
symbol(String symbolName, IAST assumptionAST, EvalEngine engine)
Get or create a user defined symbol which is retrieved from the evaluation engines context path.static ISymbol
symbol(Context context, String symbolName, EvalEngine engine)
static String
symbolNameNormalized(String symbolName)
static IAST
SymbolQ(IExpr x)
SymbolQ(x)static IBuiltInSymbol
symjify(boolean value)
static INum
symjify(double value)
static IInteger
symjify(long value)
static IExpr
symjify(Object object)
Converts and evaluates arbitrary expressions to a Symja type.static IExpr
symjify(Object object, boolean evaluate)
Converts and evaluates arbitrary expressions to a Symja type.static IExpr
symjify(String str)
Parses and evaluates a Java string to a Symja expression.static IExpr
symjify(String str, boolean evaluate)
Parses a Java string to a Symja expression.static IAST
Symmetric(IExpr a0)
Full symmetrystatic IAST
SymmetricMatrixQ(IExpr a0)
See SymmetricMatrixQstatic IAST
Table(IExpr expr, IExpr iterationSpecification)
See Tablestatic IAST
Table(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2)
static IASTMutable
TagSet(IExpr a0, IExpr a1, IExpr a2)
static IASTMutable
TagSetDelayed(IExpr a0, IExpr a1, IExpr a2)
static IAST
Take(IExpr a0, IExpr a1)
See Takestatic IASTMutable
TakeLargest(IExpr a0, IExpr a1)
static IASTMutable
TakeLargestBy(IExpr a0, IExpr a1, IExpr a2)
static IASTMutable
TakeSmallest(IExpr a0, IExpr a1)
static IASTMutable
TakeSmallestBy(IExpr a0, IExpr a1, IExpr a2)
static IAST
Tan(IExpr z)
Returns the tangent ofz
(measured in Radians).static IAST
Tanh(IExpr z)
See Tanhstatic IAST
Taylor(IExpr a0, IExpr a1)
static IAST
TemplateSlot(IExpr a0)
static IAST
TemplateSlot(IExpr a0, IExpr a1)
static IAST
TensorDimensions(IExpr a0)
static IAST
tensorList(int n, Integer... numbers)
For positive n, add the first n elements ofnumbers
to the list.For negative n, add the last n elements ofnumbers
to the list.static IAST
TensorRank(IExpr a0)
static IAST
TensorSymmetry(IExpr a0)
static IAST
TensorSymmetry(IExpr a0, IExpr a1)
static IASTMutable
ternaryAST3(IExpr head, IExpr arg1, IExpr arg2, IExpr arg3)
Create a functionhead(arg1, arg2, arg3)
with 3 argument as anAST3
mutable object without evaluation.static IAST
TeXForm(IExpr expr)
See TeXFormstatic IAST
Text(IExpr expr, IAST coords)
static IAST
Thread(IExpr a0)
See Threadstatic IAST
ThreeJSymbol(IExpr arg1, IExpr arg2, IExpr arg3)
static IAST
Throw(IExpr a)
See Throwstatic IAST
TimeConstrained(IExpr a0, IExpr a1)
See TimeConstrainedstatic IAST
TimeConstrained(IExpr a0, IExpr a1, IExpr a2)
See TimeConstrainedstatic IASTAppendable
Times()
See: Timesstatic IAST
Times(long num, IExpr... a)
See: Timesstatic IASTAppendable
Times(IExpr x)
See: Timesstatic IAST
Times(IExpr... a)
Define aTimes()
expressiona1 * a2 * ...
for multiplication.static IASTMutable
Times(IExpr x, IExpr y)
Define aTimes()
expressionx * y
for multiplication.static IAST
Times(IExpr x, IExpr y, IExpr z)
Define aTimes()
expressiona0 * a1 * a2
for multiplication.static IASTAppendable
TimesAlloc(int initialCapacity)
Create a Times() function with allocated space for size elements.static IExpr
timesDistribute(IExpr x, IExpr y, EvalEngine engine)
static IAST
ToExpression(IExpr a0)
See ToExpressionstatic IAST
Together(IExpr a0)
See Togetherstatic int
toIntDefault(double value)
Converts this number to anint
value; this method returnsInteger.MIN_VALUE
, if the value of this integer isn't in the rangejava.lang.Integer.MIN_VALUE
+1 tojava.lang.Integer.MAX_VALUE
-1 or the expression is not convertible to theint
range.static int
toIntDefault(double value, int defaultValue)
Converts this number to anint
value; this method returnsdefaultValue
, if the value of this integer isn't in the rangejava.lang.Integer.MIN_VALUE
+1 tojava.lang.Integer.MAX_VALUE
-1 or the expression is not convertible to theint
range.static IAST
ToIntervalData(IExpr expr)
static IAST
ToIntervalData(IExpr expr, IExpr variable)
static IAST
ToPolarCoordinates(IExpr a0)
static IAST
ToSphericalCoordinates(IExpr a0)
static IAST
Total(IExpr a0)
See Totalstatic IAST
Tr(IExpr a0)
See Trstatic IAST
Trace(IExpr a0)
static IAST
TransformationFunction(IExpr a0)
static IAST
TranslationTransform(IExpr a0)
static IAST
Transpose(IExpr list)
See Transposestatic IAST
Triangle(IAST list)
static IAST
TrigExpand(IExpr expr)
See TrigExpandstatic IAST
TrigReduce(IExpr expr)
See TrigReducestatic IAST
TrigSimplifyFu(IExpr expr)
static IAST
TrigToExp(IExpr expr)
See TrigToExpstatic IAST
TrueQ(IExpr expr)
See TrueQstatic IASTAppendable
unary(IExpr head, IExpr arg)
Create a functionhead(arg)
with 1 argument without evaluation.static IASTMutable
unaryAST1(IExpr head, IExpr arg)
Create a functionhead(arg)
with 1 argument as anAST1
mutable object without evaluation.static IAST
Underflow()
static IAST
UndirectedEdge(IExpr a, IExpr b)
UndirectedEdge
is an undirected edge between the verticesa
andb
in a `graph` object.static IAST
Unequal(IExpr lhs, IExpr rhs)
static IAST
Unevaluated(IExpr a0)
static IAST
UniformDistribution(IExpr a)
static IAST
Union(IExpr list1)
static IAST
Union(IExpr list1, IExpr list2)
static IAST
Unique(IExpr a0)
static IAST
UnitConvert(IExpr quantity)
Convert thequantity
to the base unit.static IAST
UnitConvert(IExpr quantity, IExpr unit)
Convert thequantity
to the givenunit
.static IAST
UnitStep(IExpr a0)
static IAST
UnsameQ(IExpr lhs, IExpr rhs)
static IAST
Unset(IExpr a0)
static IAST
UpSet(IExpr a0, IExpr a1)
static IAST
UpSetDelayed(IExpr a0, IExpr a1)
static String
usage(String symbolName)
Print the documentation for the given symbol name.static String
usage(ISymbol head)
Print the documentation for the given symbol.static IAST
Variables(IExpr a0)
static IAST
Variance(IExpr a0)
static IAST
vector(IntFunction<? extends IExpr> iFunction, int n)
Generate a vector withn
elements.static IAST
Vectors(IExpr a0)
static IAST
Vectors(IExpr a0, IExpr a1)
static IAST
WeberE(IExpr v, IExpr z)
static IAST
WeberE(IExpr v, IExpr m, IExpr z)
static IAST
WeibullDistribution(IExpr a0, IExpr a1)
static IAST
WeibullDistribution(IExpr a0, IExpr a1, IExpr a2)
static IAST
While(IExpr test, IExpr body)
static IAST
WhittakerM(IExpr a0, IExpr a1, IExpr a2)
static IAST
WhittakerW(IExpr a0, IExpr a1, IExpr a2)
static IAST
With(IExpr listOfLocalVariables, IExpr expr)
Evaluatesexpr
for thelistOfLocalVariables
by replacing the local variables inexpr
.static IAST
ZeroSymmetric(IExpr a0)
Symmetry of a zero tensor.static IAST
Zeta(IExpr s)
static IAST
Zeta(IExpr s, IExpr a)
static IAST
ZTransform(IExpr expr, IExpr n, IExpr z)
static IInteger
ZZ(int integerValue)
Create an integer number by using the internal small integer number cache.static IInteger
ZZ(long integerValue)
Create an integer number.static IInteger
ZZ(String integerString, int radix)
Create a large integer number.static IInteger
ZZ(BigInteger integerValue)
Create a large integer number.static IInteger
ZZUniqueReference(int integerValue)
Create a new integer number without using the internal small integer number cache.
-
-
-
Field Detail
-
REMEMBER_INTEGER_CACHE
public static final com.google.common.cache.Cache<IAST,IExpr> REMEMBER_INTEGER_CACHE
In computing, memoization or memoisation is an optimization technique used primarily to speed up computer programs by storing the results of expensive function calls and returning the cached result when the same inputs occur again. This cache is especially used for recursive integer functions to remember the results of the recursive call. See: Wikipedia - Memoization
-
PREDEFINED_INTERNAL_FORM_STRINGS
public static final Map<String,String> PREDEFINED_INTERNAL_FORM_STRINGS
The map for predefined strings for theIExpr.internalFormString(boolean, int)
method.
-
SYMBOL_OBSERVER
public static final ISymbolObserver SYMBOL_OBSERVER
-
NIL
public static final AbstractAST.NILPointer NIL
The constant objectNIL
(not in list) indicates in the evaluation process that no evaluation was possible (i.e. no further definition was found to create a new expression from the existing one).- See Also:
Optional.isPresent()
-
INVALID
public static final AbstractAST.NILPointer INVALID
-
a_
public static final IPattern a_
Used to represent a formal patterna_
that will be used only for predefined pattern-matching rules and can match one expression.
-
b_
public static final IPattern b_
Used to represent a formal patternb_
that will be used only for predefined pattern-matching rules and can match one expression.
-
c_
public static final IPattern c_
Used to represent a formal patternc_
that will be used only for predefined pattern-matching rules and can match one expression.
-
d_
public static final IPattern d_
Used to represent a formal patternd_
that will be used only for predefined pattern-matching rules and can match one expression.
-
e_
public static final IPattern e_
Used to represent a formal patterne_
that will be used only for predefined pattern-matching rules and can match one expression.
-
f_
public static final IPattern f_
Used to represent a formal patternf_
that will be used only for predefined pattern-matching rules and can match one expression.
-
g_
public static final IPattern g_
Used to represent a formal patterng_
that will be used only for predefined pattern-matching rules and can match one expression.
-
h_
public static final IPattern h_
Used to represent a formal patternh_
that will be used only for predefined pattern-matching rules and can match one expression.
-
i_
public static final IPattern i_
Used to represent a formal patterni_
that will be used only for predefined pattern-matching rules and can match one expression.
-
j_
public static final IPattern j_
Used to represent a formal patternj_
that will be used only for predefined pattern-matching rules and can match one expression.
-
k_
public static final IPattern k_
Used to represent a formal patternk_
that will be used only for predefined pattern-matching rules and can match one expression.
-
l_
public static final IPattern l_
Used to represent a formal patternl_
that will be used only for predefined pattern-matching rules and can match one expression.
-
m_
public static final IPattern m_
Used to represent a formal patternm_
that will be used only for predefined pattern-matching rules and can match one expression.
-
n_
public static final IPattern n_
Used to represent a formal patternn_
that will be used only for predefined pattern-matching rules and can match one expression.
-
o_
public static final IPattern o_
Used to represent a formal patterno_
that will be used only for predefined pattern-matching rules and can match one expression.
-
p_
public static final IPattern p_
Used to represent a formal patternp_
that will be used only for predefined pattern-matching rules and can match one expression.
-
q_
public static final IPattern q_
Used to represent a formal patternq_
that will be used only for predefined pattern-matching rules and can match one expression.
-
r_
public static final IPattern r_
Used to represent a formal patternr_
that will be used only for predefined pattern-matching rules and can match one expression.
-
s_
public static final IPattern s_
Used to represent a formal patterns_
that will be used only for predefined pattern-matching rules and can match one expression.
-
t_
public static final IPattern t_
Used to represent a formal patternt_
that will be used only for predefined pattern-matching rules and can match one expression.
-
u_
public static final IPattern u_
Used to represent a formal patternu_
that will be used only for predefined pattern-matching rules and can match one expression.
-
v_
public static final IPattern v_
Used to represent a formal patternv_
that will be used only for predefined pattern-matching rules and can match one expression.
-
w_
public static final IPattern w_
Used to represent a formal patternw_
that will be used only for predefined pattern-matching rules and can match one expression.
-
x_
public static final IPattern x_
Used to represent a formal patternx_
that will be used only for predefined pattern-matching rules and can match one expression.
-
y_
public static final IPattern y_
Used to represent a formal patterny_
that will be used only for predefined pattern-matching rules and can match one expression.
-
z_
public static final IPattern z_
Used to represent a formal patternz_
that will be used only for predefined pattern-matching rules and can match one expression.
-
x__
public static final IPatternSequence x__
Used to represent a formal pattern sequencex__
that will be used only for predefined pattern-matching rules and can match any sequence of one or more expressions.
-
y__
public static final IPatternSequence y__
Used to represent a formal pattern sequencey__
that will be used only for predefined pattern-matching rules and can match any sequence of one or more expressions.
-
z__
public static final IPatternSequence z__
Used to represent a formal pattern sequencez__
that will be used only for predefined pattern-matching rules and can match any sequence of one or more expressions.
-
x___
public static final IPatternSequence x___
Used to represent a formal null pattern sequencex___
that will be used only for predefined pattern-matching rules and can match any sequence of zero or more expressions.
-
y___
public static final IPatternSequence y___
Used to represent a formal null pattern sequencey___
that will be used only for predefined pattern-matching rules and can match any sequence of zero or more expressions.
-
z___
public static final IPatternSequence z___
Used to represent a formal null pattern sequencez___
that will be used only for predefined pattern-matching rules and can match any sequence of zero or more expressions.
-
A_
public static final IPattern A_
-
B_
public static final IPattern B_
-
C_
public static final IPattern C_
-
F_
public static final IPattern F_
-
G_
public static final IPattern G_
-
P_
public static final IPattern P_
-
Q_
public static final IPattern Q_
-
m_Integer
public static final IPattern m_Integer
-
n_Integer
public static final IPattern n_Integer
-
a_Symbol
public static final IPattern a_Symbol
-
b_Symbol
public static final IPattern b_Symbol
-
c_Symbol
public static final IPattern c_Symbol
-
d_Symbol
public static final IPattern d_Symbol
-
e_Symbol
public static final IPattern e_Symbol
-
f_Symbol
public static final IPattern f_Symbol
-
g_Symbol
public static final IPattern g_Symbol
-
h_Symbol
public static final IPattern h_Symbol
-
i_Symbol
public static final IPattern i_Symbol
-
j_Symbol
public static final IPattern j_Symbol
-
k_Symbol
public static final IPattern k_Symbol
-
l_Symbol
public static final IPattern l_Symbol
-
m_Symbol
public static final IPattern m_Symbol
-
n_Symbol
public static final IPattern n_Symbol
-
o_Symbol
public static final IPattern o_Symbol
-
p_Symbol
public static final IPattern p_Symbol
-
q_Symbol
public static final IPattern q_Symbol
-
r_Symbol
public static final IPattern r_Symbol
-
s_Symbol
public static final IPattern s_Symbol
-
t_Symbol
public static final IPattern t_Symbol
-
u_Symbol
public static final IPattern u_Symbol
-
v_Symbol
public static final IPattern v_Symbol
-
w_Symbol
public static final IPattern w_Symbol
-
x_Symbol
public static final IPattern x_Symbol
-
y_Symbol
public static final IPattern y_Symbol
-
z_Symbol
public static final IPattern z_Symbol
-
a_DEFAULT
public static final IPattern a_DEFAULT
-
b_DEFAULT
public static final IPattern b_DEFAULT
-
c_DEFAULT
public static final IPattern c_DEFAULT
-
d_DEFAULT
public static final IPattern d_DEFAULT
-
e_DEFAULT
public static final IPattern e_DEFAULT
-
f_DEFAULT
public static final IPattern f_DEFAULT
-
g_DEFAULT
public static final IPattern g_DEFAULT
-
h_DEFAULT
public static final IPattern h_DEFAULT
-
i_DEFAULT
public static final IPattern i_DEFAULT
-
j_DEFAULT
public static final IPattern j_DEFAULT
-
k_DEFAULT
public static final IPattern k_DEFAULT
-
l_DEFAULT
public static final IPattern l_DEFAULT
-
m_DEFAULT
public static final IPattern m_DEFAULT
-
n_DEFAULT
public static final IPattern n_DEFAULT
-
o_DEFAULT
public static final IPattern o_DEFAULT
-
p_DEFAULT
public static final IPattern p_DEFAULT
-
q_DEFAULT
public static final IPattern q_DEFAULT
-
r_DEFAULT
public static final IPattern r_DEFAULT
-
s_DEFAULT
public static final IPattern s_DEFAULT
-
t_DEFAULT
public static final IPattern t_DEFAULT
-
u_DEFAULT
public static final IPattern u_DEFAULT
-
v_DEFAULT
public static final IPattern v_DEFAULT
-
w_DEFAULT
public static final IPattern w_DEFAULT
-
x_DEFAULT
public static final IPattern x_DEFAULT
-
y_DEFAULT
public static final IPattern y_DEFAULT
-
z_DEFAULT
public static final IPattern z_DEFAULT
-
A_DEFAULT
public static final IPattern A_DEFAULT
-
B_DEFAULT
public static final IPattern B_DEFAULT
-
C_DEFAULT
public static final IPattern C_DEFAULT
-
F_DEFAULT
public static final IPattern F_DEFAULT
-
G_DEFAULT
public static final IPattern G_DEFAULT
-
P_DEFAULT
public static final IPattern P_DEFAULT
-
Q_DEFAULT
public static final IPattern Q_DEFAULT
-
C0
public static final IInteger C0
Constant integer "0"
-
C1
public static final IInteger C1
Constant integer "1"
-
C2
public static final IInteger C2
Constant integer "2"
-
C3
public static final IInteger C3
Constant integer "3"
-
C4
public static final IInteger C4
Constant integer "4"
-
C5
public static final IInteger C5
Constant integer "5"
-
C6
public static final IInteger C6
Constant integer "6"
-
C7
public static final IInteger C7
Constant integer "7"
-
C8
public static final IInteger C8
Constant integer "8"
-
C9
public static final IInteger C9
Constant integer "9"
-
C10
public static final IInteger C10
Constant integer "10"
-
C100
public static final IInteger C100
Constant integer "100"
-
C1000
public static final IInteger C1000
Constant integer "1000"
-
CI
public static final IComplex CI
Complex imaginary unit "0 + I". The parsed symbol "I" is converted on input to this constant.
-
CNI
public static final IComplex CNI
Complex negative imaginary unit "0 - I".
-
C1D2
public static final IFraction C1D2
Constant fraction "1/2"
-
C3D2
public static final IFraction C3D2
Constant fraction "3/2"
-
C3D4
public static final IFraction C3D4
Constant fraction "3/4"
-
C5D2
public static final IFraction C5D2
Constant fraction "5/2"
-
CN1D2
public static final IFraction CN1D2
Constant fraction "-1/2"
-
CN3D2
public static final IFraction CN3D2
Constant fraction "-3/2"
-
C1D3
public static final IFraction C1D3
Constant fraction "1/3"
-
CN1D3
public static final IFraction CN1D3
Constant fraction "-1/3"
-
C1D4
public static final IFraction C1D4
Constant fraction "1/4"
-
CN1D4
public static final IFraction CN1D4
Constant fraction "-1/4"
-
C1D5
public static final IFraction C1D5
Constant fraction "1/5"
-
CN1D5
public static final IFraction CN1D5
Constant fraction "-1/5"
-
C1D6
public static final IFraction C1D6
Constant fraction "1/6"
-
CN1D6
public static final IFraction CN1D6
Constant fraction "-1/6"
-
C2D3
public static final IFraction C2D3
Constant fraction "2/3"
-
CN2D3
public static final IFraction CN2D3
Constant fraction "-2/3"
-
CND1
public static final Num CND1
Constant double "-1.0"
-
CD0
public static final Num CD0
Constant double "0.0"
-
CD1
public static final Num CD1
Constant double "1.0"
-
CDI
public static final IComplexNum CDI
Complex numerical imaginary unit.
-
CDNI
public static final IComplexNum CDNI
Complex negative numerical imaginary unit.
-
CEmptyString
public static final IStringX CEmptyString
Represents the empty Smyja string""
-
CEmptySequence
public static final IAST CEmptySequence
RepresentsSequence()
(i.e. the constant empty list)
-
CEmptyList
public static final IAST CEmptyList
RepresentsList()
(i.e. the constant empty list)
-
CEmptyInterval
public static final IAST CEmptyInterval
RepresentsInterval()
(i.e. the constant empty interval with closed ends)
-
CEmptyIntervalData
public static final IAST CEmptyIntervalData
RepresentsInterval()
(i.e. the constant empty interval with closed/open ends)
-
CMissingNotFound
public static final IAST CMissingNotFound
RepresentsMissing("NotFound")
-
CListC0
public static final IAST CListC0
RepresentsList(0)
-
CListC1
public static final IAST CListC1
RepresentsList(1)
-
CListCN1
public static final IAST CListCN1
RepresentsList(-1)
. Can be used to specify the "leaf"VisitorLevelSpecification
of an expression.
-
CListC0C0
public static final IAST CListC0C0
RepresentsList(0,0)
-
CListC1C1
public static final IAST CListC1C1
RepresentsList(1,1)
-
CListC1C2
public static final IAST CListC1C2
RepresentsList(1,2)
-
CListC2
public static final IAST CListC2
RepresentsList(2)
-
CListC2C1
public static final IAST CListC2C1
RepresentsList(2,1)
-
CListC2C2
public static final IAST CListC2C2
RepresentsList(2,2)
-
CInfinity
public static final IAST CInfinity
RepresentsInfinity
(i.e.Infinity->DirectedInfinity(1)
)
-
CReturnFalse
public static final IAST CReturnFalse
RepresentsReturn(False)
-
CReturnTrue
public static final IAST CReturnTrue
RepresentsReturn(True)
-
CThrowFalse
public static final IAST CThrowFalse
RepresentsThrow(False)
-
CThrowTrue
public static final IAST CThrowTrue
RepresentsThrow(True)
-
oo
public static final IAST oo
Alias for CInfinity. RepresentsInfinity
(i.e.Infinity->DirectedInfinity(1)
)
-
CNInfinity
public static final IAST CNInfinity
Represents-Infinity
(i.e.-Infinity->DirectedInfinity(-1)
)
-
Noo
public static final IAST Noo
Alias for CNInfinity. Represents-Infinity
(i.e.-Infinity->DirectedInfinity(-1)
)
-
CIInfinity
public static final IAST CIInfinity
RepresentsI*Infinity
(i.e.I*Infinity->DirectedInfinity(I)
)
-
CNIInfinity
public static final IAST CNIInfinity
Represents-I*Infinity
(i.e.-I*Infinity->DirectedInfinity(-I)
)
-
CComplexInfinity
public static final IAST CComplexInfinity
RepresentsComplexInfinity
(i.e.ComplexInfinity->DirectedInfinity()
)
-
CNPi
public static final IAST CNPi
Represents-Pi
as Symja expressionTimes(CN1, Pi)
-
CN2Pi
public static final IAST CN2Pi
Represents-2*Pi
as Symja expressionTimes(CN2, Pi)
-
C2Pi
public static final IAST C2Pi
Represents2*Pi
as Symja expressionTimes(C2, Pi)
-
CNPiHalf
public static final IAST CNPiHalf
Represents-Pi/2
as Symja expressionTimes(CN1D2, Pi)
-
CPiHalf
public static final IAST CPiHalf
RepresentsPi/2
as Symja expressionTimes(C1D2, Pi)
-
CNPiThird
public static final IAST CNPiThird
Represents-Pi/3
as Symja expressionTimes(CN1D3, Pi)
-
CPiThird
public static final IAST CPiThird
RepresentsPi/3
as Symja expressionTimes(C1D3, Pi)
-
CNPiQuarter
public static final IAST CNPiQuarter
Represents-Pi/4
as Symja expressionTimes(CN1D4, Pi)
-
CPiQuarter
public static final IAST CPiQuarter
RepresentsPi/4
as Symja expressionTimes(C1D4, Pi)
-
CSqrtPi
public static final IAST CSqrtPi
RepresentsSqrt(Pi)
-
CSqrt2
public static final IAST CSqrt2
RepresentsSqrt(2)
-
CSqrt3
public static final IAST CSqrt3
RepresentsSqrt(3)
-
CSqrt5
public static final IAST CSqrt5
RepresentsSqrt(5)
-
CSqrt6
public static final IAST CSqrt6
RepresentsSqrt(6)
-
CSqrt7
public static final IAST CSqrt7
RepresentsSqrt(7)
-
CSqrt10
public static final IAST CSqrt10
RepresentsSqrt(10)
-
C1DSqrt2
public static final IAST C1DSqrt2
Represents1/Sqrt(2)
-
C1DSqrt3
public static final IAST C1DSqrt3
Represents1/Sqrt(3)
-
C1DSqrt5
public static final IAST C1DSqrt5
Represents1/Sqrt(5)
-
C1DSqrt6
public static final IAST C1DSqrt6
Represents1/Sqrt(6)
-
C1DSqrt7
public static final IAST C1DSqrt7
Represents1/Sqrt(7)
-
C1DSqrt10
public static final IAST C1DSqrt10
Represents1/Sqrt(10)
-
Slot1
public static final IAST Slot1
Represents#1
, the first argument of a pure function.
-
Slot2
public static final IAST Slot2
Represents#2
, the second argument of a pure function.
-
Slot3
public static final IAST Slot3
Represents#3
, the third argument of a pure function.
-
EXPR_FIELD
public static final org.hipparchus.Field<IExpr> EXPR_FIELD
-
CN1
public static final IInteger CN1
Constant integer "-1"
-
CN2
public static final IInteger CN2
Constant integer "-2"
-
CN3
public static final IInteger CN3
Constant integer "-3"
-
CN4
public static final IInteger CN4
Constant integer "-4"
-
CN5
public static final IInteger CN5
Constant integer "-5"
-
CN6
public static final IInteger CN6
Constant integer "-6"
-
CN7
public static final IInteger CN7
Constant integer "-7"
-
CN8
public static final IInteger CN8
Constant integer "-8"
-
CN9
public static final IInteger CN9
Constant integer "-9"
-
CN10
public static final IInteger CN10
Constant integer "-10"
-
-
Method Detail
-
isSystemInitialized
public static boolean isSystemInitialized()
-
getPredefinedPatternSequence
public static IPatternSequence getPredefinedPatternSequence(String key)
-
await
public static final void await() throws InterruptedException
Causes the current thread to wait until the main initialization has finished.- Throws:
InterruptedException
-
$
public static final IASTMutable $(IExpr head, IExpr... a)
Create a new abstract syntax tree (AST).- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.a
-- Returns:
-
$bs
public static PatternSequence $bs(IExpr condition)
Create aBlankSequence[condition]
pattern object for pattern-matching and term rewriting- Parameters:
condition
- additional condition which should be checked in pattern-matching- Returns:
- IPattern
-
$bns
public static PatternSequence $bns(IExpr condition)
Create aBlankNullSequence[condition]
pattern object for pattern-matching and term rewriting- Parameters:
condition
- additional condition which should be checked in pattern-matching- Returns:
- IPattern
-
$b
public static IPattern $b()
Create aBlank[]
pattern object for pattern-matching and term rewriting- Returns:
- IPattern
-
$b
public static IPattern $b(IExpr condition)
Create aBlank[condition]
pattern object for pattern-matching and term rewriting- Parameters:
condition
- additional condition which should be checked in pattern-matching- Returns:
- IPattern
-
$b
public static IPattern $b(IExpr condition, boolean def)
Create aBlank[condition]
pattern object for pattern-matching and term rewriting- Parameters:
condition
- additional condition which should be checked in pattern-matchingdef
- iftrue
use a default value in pattern-matching if an argument is optional- Returns:
- IPattern
-
$p
public static IPattern $p(ISymbol symbol)
Create aPattern[]
pattern for pattern-matching and term rewriting- Parameters:
symbol
-- Returns:
- IPattern
-
$p
public static IPattern $p(ISymbol symbol, boolean matchDefaultValue)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbol
-matchDefaultValue
- iftrue
, the pattern can match to a default value associated with the AST's head the pattern is used in- Returns:
- IPattern
-
$p
public static IPattern $p(ISymbol symbol, IExpr headerCheck)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbol
-headerCheck
- additional condition which should be checked for the header of an expression in pattern-matching- Returns:
- IPattern
-
$p
public static IPattern $p(ISymbol symbol, IExpr headerCheck, boolean matchDefaultValue)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbol
-headerCheck
- additional condition which should be checked for the header of an expressionmatchDefaultValue
- iftrue
, the pattern can match to a default value associated with the AST's head the pattern is used in- Returns:
- IPattern
-
$p
public static IPattern $p(String symbolName)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbolName
-- Returns:
- IPattern
-
$p
public static IPattern $p(String symbolName, boolean def)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbolName
-def
- use a default value for this pattern if necessary- Returns:
- IPattern
-
$p
public static IPattern $p(String symbolName, IExpr check)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbolName
-check
- additional condition which should be checked in pattern-matching- Returns:
- IPattern
-
$p
public static IPattern $p(String symbolName, IExpr check, boolean def)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbolName
-check
- additional condition which should be checked in pattern-matchingdef
- use a default value for this pattern if necessary- Returns:
- IPattern
-
pattern
public static IPattern pattern(ISymbol symbol)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbol
-- Returns:
- IPattern
-
pattern
public static IPattern pattern(ISymbol symbol, IExpr check, boolean def)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbol
-check
- additional condition which should be checked in pattern-matchingdef
- iftrue
, the pattern can match to a default value associated with the AST's head the pattern is used in.- Returns:
- IPattern
-
$ps
public static IPatternSequence $ps(ISymbol symbol)
Create a new PatternSequenceBlankSequence
.- Parameters:
symbol
-- Returns:
- IPattern
-
$ps
public static IPatternSequence $ps(ISymbol symbol, boolean zeroArgsAllowed)
Create a new PatternSequenceBlankSequence
orBlankNullSequence
.- Parameters:
symbol
- the associated symbol of the pattern sequence. Maybenull
.zeroArgsAllowed
- iftrue
, 0 arguments are allowed, otherwise the number of args has to be >= 1.- Returns:
-
$ps
public static IPatternSequence $ps(ISymbol symbol, IExpr check)
Create a new PatternSequenceBlankSequence
orBlankNullSequence
.- Parameters:
symbol
- the associated symbol of the pattern sequence. Maybenull
.check
- a header check.Maybenull
.- Returns:
- IPatternSequence
-
$ps
public static IPatternSequence $ps(ISymbol symbol, IExpr check, boolean def, boolean zeroArgsAllowed)
Create a new PatternSequenceBlankSequence
orBlankNullSequence
.- Parameters:
symbol
-check
- additional condition which should be checked in pattern-matchingdef
- iftrue
, the pattern can match to a default value associated with the AST's head the pattern is used in.zeroArgsAllowed
- iftrue
0 argument sequences are allowed for this pattern- Returns:
- IPattern
-
$OptionsPattern
public static IPatternSequence $OptionsPattern()
-
$OptionsPattern
public static IPatternSequence $OptionsPattern(ISymbol symbol)
-
$OptionsPattern
public static IPatternSequence $OptionsPattern(ISymbol symbol, IExpr defaultOptions)
-
$Repeated
public static IPatternSequence $Repeated(IExpr patternExpr, int min, int max, EvalEngine engine)
- Parameters:
patternExpr
-min
- ifmin==0
RepeatedNull is assumedmax
-engine
-- Returns:
-
$ps
public static IPatternSequence $ps(String symbolName)
Create a pattern for pattern-matching and term rewriting- Parameters:
symbolName
- the name of the pattrn symbol- Returns:
- IPattern
-
SymbolQ
public static IAST SymbolQ(IExpr x)
SymbolQ(x)
is
True
ifx
is a symbol, orFalse
otherwise.Examples
>> SymbolQ(a) True >> SymbolQ(1) False >> SymbolQ(a + b) False
-
SymmetricMatrixQ
public static IAST SymmetricMatrixQ(IExpr a0)
See SymmetricMatrixQ
-
symjify
public static IExpr symjify(Object object)
Converts and evaluates arbitrary expressions to a Symja type.Java Object -> Symja object ------------------------------------- null object
S.Null
symbol IExprIExpr
type BooleanS.True
orS.False
symbol BigIntegerIInteger
value BigDecimalINum
withApfloat(java.math.BigDecimal)
value DoubleINum
with doubleValue() value FloatINum
with doubleValue() value IntegerIInteger
with intValue() value LongIInteger
with longValue() value NumberINum
with doubleValue() value java.util.Collection list of elements 1..nth element of the list give the elements of the List() Object[] a list of converted objects int[] a list ofIInteger
integer values double[] a vector ASTRealVector ofdouble
values double[][] a matrix ASTRealMatrix ofdouble
values Complex[] a list ofIComplexNum
values boolean[] a list ofS.True
orS.False
symbols- Parameters:
object
-- Returns:
- the
object
converted to aIExpr
}
-
symjify
public static IExpr symjify(Object object, boolean evaluate)
Converts and evaluates arbitrary expressions to a Symja type.Java Object -> Symja object ------------------------------------- null object
S.Null
symbol IExprIExpr
type BooleanS.True
orS.False
symbol BigIntegerIInteger
value BigDecimalINum
withApfloat(java.math.BigDecimal)
value DoubleINum
with doubleValue() value FloatINum
with doubleValue() value IntegerIInteger
with intValue() value LongIInteger
with longValue() value NumberINum
with doubleValue() value java.util.Collection list of elements 1..nth element of the list give the elements of the List() Object[] a list of converted objects int[] a list ofIInteger
integer values double[] a vector ASTRealVector ofdouble
values double[][] a matrix ASTRealMatrix ofdouble
values Complex[] a list ofIComplexNum
values boolean[] a list ofS.True
orS.False
symbols- Parameters:
object
-evaluate
- iftrue
evaluate the parsed string- Returns:
- the
object
converted to anIExpr
}
-
symjify
public static IExpr symjify(String str)
Parses and evaluates a Java string to a Symja expression. May throw an SyntaxError exception, if the string couldn't be parsed.- Parameters:
str
- the expression which should be parsed- Returns:
- Throws:
SyntaxError
-
symjify
public static IExpr symjify(String str, boolean evaluate)
Parses a Java string to a Symja expression. May throw a SyntaxError exception, if the string couldn't be parsed.- Parameters:
str
- the expression which should be parsedevaluate
- iftrue
evaluate the parsed string- Returns:
- Throws:
SyntaxError
-
symjify
public static IInteger symjify(long value)
- Parameters:
value
-- Returns:
IInteger
integer value
-
symjify
public static IBuiltInSymbol symjify(boolean value)
-
$s
public static ISymbol $s(String symbolName)
Get or create a global predefined symbol which is retrieved from the SYSTEM context map or created or retrieved from the SYSTEM context variables map.
- Parameters:
symbolName
- the name of the symbol
-
$rubi
public static ISymbol $rubi(String symbolName, IEvaluator evaluator)
-
$str
public static final IStringX $str(char ch)
-
$str
public static final IStringX $str(String str)
Create a string expression- Parameters:
str
-- Returns:
-
AddSides
public static IASTMutable AddSides(IExpr equationOrInequality, IExpr a1)
-
and
public static IExpr and(IExpr a, BigInteger i)
-
and
public static IExpr and(BigInteger i, IExpr b)
-
And
public static IASTAppendable And()
-
AmbientLight
public static IASTMutable AmbientLight(IExpr color)
-
And
public static IAST And(IExpr... expr)
expr1 && expr2 && expr3 ...
evaluates each expression in turn, returningS.False
as soon as an expression evaluates toS.False
. If all expressions evaluate toS.True
, it returnsS.True
.See: And
- Parameters:
expr
-- Returns:
-
And
public static IAST And(IExpr expr1, IExpr expr2)
expr1 && expr2
evaluates each expression in turn, returningS.False
as soon as an expression evaluates toS.False
. If all expressions evaluate toS.True
, it returnsS.True
.See: And
- Parameters:
expr1
-expr2
-- Returns:
-
And
public static IAST And(IExpr expr1, IExpr expr2, IExpr expr3)
expr1 && expr2 && expr3
evaluates each expression in turn, returningS.False
as soon as an expression evaluates toS.False
. If all expressions evaluate toS.True
, it returnsS.True
.See: And
- Parameters:
expr1
-expr2
-expr3
-- Returns:
-
Apply
public static IASTMutable Apply(IExpr a0, IExpr a1)
Operator@@
- Parameters:
a0
-a1
-- Returns:
-
ApplySides
public static IASTMutable ApplySides(IExpr a0, IExpr equationOrInequality)
-
ApplyListC1
public static IASTMutable ApplyListC1(IExpr a0, IExpr a1)
Operator@@@
- Parameters:
a0
-a1
-- Returns:
-
ArrayQ
public static IAST ArrayQ(IExpr a0)
'ArrayQ(expr)
tests whether expr is a full array.
'ArrayQ(expr, pattern)
also tests whether the array depth of expr matches pattern.
'ArrayQ(expr, pattern, test)
furthermore tests whether
test
yieldsTrue
for all elements of expr.Examples
>> ArrayQ(a) False >> ArrayQ({a}) True >> ArrayQ({{{a}},{{b,c}}}) False >> ArrayQ({{a, b}, {c, d}}, 2, SymbolQ) True
-
Arrays
public static IAST Arrays(IAST dimension)
The domain of arrays.- Parameters:
dimension
-- Returns:
Arrays(dimensions, Complexes, {})
.
-
Arrays
public static IAST Arrays(IAST dimension, ISymbol domain)
The domain of arrays.- Parameters:
dimension
-domain
-- Returns:
Arrays(dimensions, domain, {})
.
-
Arrays
public static IAST Arrays(IAST dimension, ISymbol domain, IAST symmetry)
The domain of arrays.- Parameters:
dimension
-domain
-symmetry
-- Returns:
Arrays(dimensions, domain, symmetry)
.
-
assoc
public static IAssociation assoc(IAST listOfRules)
Create an association data structure<| x0->y0, x1->y1, ... |>
from a list of rules{x0->y0, x1->y1, ... }
.- Parameters:
listOfRules
- a list of rules{x0->y0, x1->y1, ... }
- Returns:
-
assoc
public static IAssociation assoc(IAssociation templateAssociation, Map<IExpr,IASTMutable> mapOfRules)
Create an association data structure<| x0->y0, x1->y1, ... |>
from a map of rules.- Parameters:
templateAssociation
- the template association, which determines the type of rule (Rule
orRuleDelayed
and the key of the new rule.mapOfRules
- a map of keys toIASTMutable
values- Returns:
-
assoc
public static IAssociation assoc()
-
sparseArray
public static ISparseArray sparseArray(IAST arrayRulesList)
Create a sparse array from the list of rules.See: SparseArray
- Parameters:
arrayRulesList
-- Returns:
- a ISparseArray instance
-
sparseArray
public static ISparseArray sparseArray(IAST arrayRulesList, int[] dimension)
Create a sparse array in the givendimension
from the list of rules.See: SparseArray
- Parameters:
arrayRulesList
-dimension
-- Returns:
- a ISparseArray instance
-
sparseArray
public static ISparseArray sparseArray(IAST denseList, IExpr defaultValue)
Create a sparse array from the dense list representation (for example dense vectors and matrices)- Parameters:
denseList
-defaultValue
- default value for positions not specified in the dense list representation.- Returns:
null
if a newSparseArrayExpr
cannot be created
-
sparseMatrix
public static ISparseArray sparseMatrix(BiIntFunction<? extends IExpr> binaryFunction, int n, int m)
Generate an x m
sparse matrix. The indices start in Java convention with0
.- Parameters:
binaryFunction
- if the returned value unequals0
, the value will be stored in the sparse matrixn
- the number of rows of the matrix.m
- the number of columns of the matrix.- Returns:
-
ast
public static IAST ast(IAST f, IExpr head, boolean include, int first, int last)
Creates a new AST from the givenast
andhead
. ifinclude
is set totrue
all arguments from index first to last-1 are copied in the new list ifinclude
is set tofalse
all arguments excluded from index first to last-1 are copied in the new list
-
ast
public static final IASTAppendable ast(IExpr head)
Create a new abstract syntax tree (AST).- Parameters:
head
- the header expression of the function. In the case, that theast
represents a function likef[x,y], Sin[x],...
, thehead
must be an instance of typeISymbol
-
ast
public static IASTAppendable ast(IExpr head, int initialCapacity)
Create a new abstract syntax tree (AST). Elements can be added to the end of the created AST instance with theIASTAppendable.append(IExpr)
method.- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.initialCapacity
- the initial capacity (i.e. number of arguments without the header element) of the list.- Returns:
-
ast
@Deprecated public static IASTAppendable ast(IExpr head, int initialCapacity, boolean initNull)
Deprecated.Create a new abstract syntax tree (AST).- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.initialCapacity
- the initial capacity (i.e. number of arguments without the header element) of the list.initNull
- initialize all elements withnull
.- Returns:
-
ast
public static IASTAppendable ast(IExpr head, Collection<? extends IExpr> collection)
Create a new abstract syntax tree (AST). Elements can be added at the end of the created AST instance with theIASTAppendable.append(IExpr)
method.- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.collection
- the collection which holds the elements which should be appended- Returns:
-
ast
public static IASTAppendable ast(IExpr head, Collection<? extends IExpr> collection, int initialCapacity)
- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.collection
- the collection which holds the elements which should be appendedinitialCapacity
- the additional capacity added to the collections size (i.e. number of arguments without the header element) of the list.- Returns:
-
astMutable
public static IASTMutable astMutable(IExpr head, int initialCapacity)
Create a new abstract syntax tree (AST) with pre- allocated elements set tonull
. Elements can be set in the created AST instance with theIASTMutable.set(int, IExpr)
method.- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.initialCapacity
- the initial capacity (i.e. number of arguments without the header element) of the list.- Returns:
-
constantArray
public static IASTAppendable constantArray(IExpr value, int copies)
Create a newList()
withcopies
number of arguments, which are set tovalue
.- Parameters:
value
- initialize all elements withvalue
.copies
- the initial capacity (i.e. number of arguments without the header element) of the list.- Returns:
-
constantArray
public static IASTAppendable constantArray(IExpr head, IExpr value, int copies)
Create a new abstract syntax tree (AST) with ahead
andcopies
number of arguments, which are set tovalue
.- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.value
- initialize all elements withvalue
.copies
- the initial capacity (i.e. number of arguments without the header element) of the list.- Returns:
-
ast
public static IASTAppendable ast(IExpr[] arr, IExpr head)
Create a new function expression (AST - abstract syntax tree).- Parameters:
arr
- an array of arguments for this function expressionhead
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.- Returns:
-
ast
public static IASTAppendable ast(ISymbol head, int[] arr)
Create a new function expression (AST - abstract syntax tree), where all arguments are Javaint
values.- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.arr
- the integer arguments of the function expression- Returns:
-
ast
public static IASTAppendable ast(ISymbol head, org.hipparchus.complex.Complex[] arr)
Create a new function expression (AST - abstract syntax tree), where all arguments are Javaorg.hipparchus.complex.Complex
values.- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.arr
- theorg.hipparchus.complex.Complex
arguments of the function expression- Returns:
-
ast
public static IASTAppendable ast(ISymbol head, boolean evalComplex, org.hipparchus.complex.Complex[] arr)
Create a new function expression (AST - abstract syntax tree), where all arguments are JavaComplexNum
values.- Parameters:
head
-evalComplex
- iftrue
test if the imaginary part of the complex number is zero and insert aNum
real value.arr
- the complex number arguments- Returns:
-
AtomQ
public static IAST AtomQ(IExpr a)
AtomQ(x)
is true if
x
is an atom (an object such as a number or string, which cannot be divided into subexpressions using 'Part').Examples
>> AtomQ(x) True >> AtomQ(1.2) True >> AtomQ(2 + I) True >> AtomQ(2 / 3) True >> AtomQ(x + y) False
-
binary
public static final IASTAppendable binary(IExpr head, IExpr arg1, IExpr arg2)
Create a functionhead(arg1, arg2)
with 2 arguments without evaluation.- Parameters:
head
-arg1
-arg2
-- Returns:
-
binaryAST2
public static final IASTMutable binaryAST2(IExpr head, IExpr arg1, IExpr arg2)
Create a functionhead(arg1, arg2)
with 2 argument as anAST2
mutable object without evaluation.- Parameters:
head
-arg1
-arg2
-- Returns:
-
binaryAST2
public static final IASTMutable binaryAST2(IExpr head, String arg1, IExpr arg2)
-
binaryAST2
public static final IASTMutable binaryAST2(IExpr head, String arg1, String arg2)
-
Binomial
public static IAST Binomial(int a0, int a1)
-
BlankSequence
public static IAST BlankSequence()
-
bool
@Deprecated public static ISymbol bool(boolean value)
Deprecated.usebooleSymbol(boolean)
insteadReturns symbol "True" or "False" (type ISymbol) depending on the boolean value.- Parameters:
value
-- Returns:
-
booleSymbol
public static ISymbol booleSymbol(boolean value)
Returns symbol "True" or "False" (type ISymbol) depending on the boolean value.- Parameters:
value
-- Returns:
-
booleInteger
public static IInteger booleInteger(boolean value)
Returns integers 1 or 0 (type ISymbol) depending on the boolean valuetrue
orfalse
.- Parameters:
value
-- Returns:
-
BooleanQ
public static IAST BooleanQ(IExpr a)
BooleanQ(expr)
returns
True
ifexpr
is eitherTrue
orFalse
.Examples
>> BooleanQ(True) True >> BooleanQ(False) True >> BooleanQ(a) False >> BooleanQ(1 < 2) True >> BooleanQ("string") False >> BooleanQ(Together(x/y + y/x)) False
-
Break
public static IAST Break()
-
C
public static IAST C(int index)
-
CancelButton
public static IAST CancelButton()
-
cast
public static IExpr cast(Object obj)
Converts a given object into a MathEclipse IExpr expressionJava Object -> MathEclipse object ------------------------------------- null object Null symbol IExpr IExpr type Boolean True or False symbol BigInteger Integer value java.math.BigInteger Integer value BigDecimal Double with doubleValue() value Double Double with doubleValue() value Float Double with doubleValue() value Number Integer with longValue() value java.util.List 0-th element of the list gives the head of the function 1..nth element of the list give the arguments of the function Object[] a list of converted objects int[] a list of Integer values double[] a list of Double values double[][] a matrix (i.e. nested lists) of Double values boolean[] a list of True or False symbols
- Parameters:
obj
-- Returns:
-
CC
public static IComplex CC(IFraction re)
Create a symbolic complex numberre + I * 0
- Parameters:
re
-- Returns:
-
CC
public static IComplex CC(IRational real, IRational imag)
Create a symbolic complex numberreal + I * imag
- Parameters:
real
- the real part of the complex numberimag
- the imaginary part of the complex number- Returns:
-
CC
public static IComplex CC(long realNumerator, long realDenominator, long imagNumerator, long imagDenominator)
Create a symbolic complex number(realNumerator/realDenominator) + I * (imagNumerator/imagDenominator)
- Parameters:
realNumerator
-realDenominator
-imagNumerator
-imagDenominator
-- Returns:
-
CC
public static IComplex CC(long real, long imag)
Create a symbolic complex numberreal + I * imag
.- Parameters:
real
- the real part of the complex numberimag
- the imaginary part of the complex number- Returns:
-
CharacteristicPolynomial
public static IAST CharacteristicPolynomial(IExpr matrix, IExpr variable)
CharacteristicPolynomial(matrix, var) - computes the characteristic polynomial of a `matrix` for the variable `var`.- See Also:
- CharacteristicPolynomial documentation
-
chopNumber
public static INumber chopNumber(INumber arg, double delta)
Set real or imaginary parts of a numeric argument to zero, those absolute value is less than a delta.- Parameters:
arg
- a numeric numberdelta
- the delta for which the number should be set to zero- Returns:
arg
if the argument couldn't be chopped
-
chopComplex
public static org.hipparchus.complex.Complex chopComplex(org.hipparchus.complex.Complex arg)
Set real or imaginary parts of a numeric argument to zero, those absolute value is less thanConfig.DEFAULT_CHOP_DELTA
- Parameters:
arg
- a numeric number- Returns:
arg
if the argument couldn't be chopped
-
chopComplex
public static org.hipparchus.complex.Complex chopComplex(org.hipparchus.complex.Complex arg, double delta)
Set real or imaginary parts of a numeric argument to zero, those absolute value is less than a delta.- Parameters:
arg
- a numeric numberdelta
- the delta for which the number should be set to zero- Returns:
arg
if the argument couldn't be chopped
-
compareTo
public static int compareTo(IExpr a, IExpr b) throws UnsupportedOperationException
- Throws:
UnsupportedOperationException
-
compareTo
public static int compareTo(IExpr a, Integer i) throws UnsupportedOperationException
- Throws:
UnsupportedOperationException
-
compareTo
public static int compareTo(IExpr a, BigInteger i) throws UnsupportedOperationException
- Throws:
UnsupportedOperationException
-
compareTo
public static int compareTo(Integer i, IExpr b) throws UnsupportedOperationException
- Throws:
UnsupportedOperationException
-
compareTo
public static int compareTo(BigInteger i, IExpr b) throws UnsupportedOperationException
- Throws:
UnsupportedOperationException
-
complex
public static IComplex complex(double realPart, double imagPart)
Create a symbolic complex number- Parameters:
realPart
- the real double value part which should be converted to a complex numberimagPart
- the imaginary double value part which should be converted to a complex number- Returns:
- IComplex
-
complex
public static IComplex complex(double realPart, double imagPart, double epsilon)
Create a symbolic complex number- Parameters:
realPart
- the real double value which should be converted to the real part of symbolic a complex numberimagPart
- the imaginary double value which should be converted to the imaginary part of symbolic a complex numberepsilon
-- Returns:
-
complexConvergent
public static IComplex complexConvergent(double realPart, double imagPart)
Create a symbolic complex number.- Parameters:
realPart
- the real double value which should be converted to the real part of symbolic a complex numberimagPart
- the imaginary double value which should be converted to the imaginary part of symbolic a complex number- Returns:
-
complex
public static IComplex complex(IRational re)
Create a symbolic complex number- Parameters:
re
-- Returns:
-
complex
public static IComplex complex(IRational re, IRational im)
Create a symbolic complex number- Parameters:
re
-im
-- Returns:
-
complex
public static IComplex complex(long real_numerator, long real_denominator, long imag_numerator, long imag_denominator)
Create a symbolic complex number- Parameters:
real_numerator
-real_denominator
-imag_numerator
-imag_denominator
-- Returns:
-
Complex
public static IAST Complex(IExpr a0, IExpr a1)
Create aComplex(a, b)
AST symbolic expression.- Parameters:
a0
-a1
-- Returns:
-
complexNum
public static IComplexNum complexNum(org.apfloat.Apcomplex c)
Return aApcomplexNum
which wraps aApcomplex
arbitrary precision floating-point complex number.- Parameters:
c
-- Returns:
-
complexNum
public static IComplexNum complexNum(org.apfloat.Apfloat realPart)
Return aApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part with imaginary part set to0
.- Parameters:
realPart
-- Returns:
- a
ApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part with imaginary part set to0
.
-
complexNum
public static IComplexNum complexNum(org.apfloat.Apfloat realPart, org.apfloat.Apfloat imaginaryPart)
Return aApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part.- Parameters:
realPart
-imaginaryPart
-- Returns:
- a
ApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part.
-
complexNum
public static IComplexNum complexNum(String realPart, String imaginaryPart, long precision)
Return aApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part.- Parameters:
realPart
-imaginaryPart
-precision
-- Returns:
- a
ApcomplexNum
which wraps twoApfloat
arbitrary precision floating-point numbers for the real and imaginary part.
-
complexNum
public static IComplexNum complexNum(org.hipparchus.complex.Complex c)
Return aComplexNum
which wraps aComplex
number with Java double values for the real and imaginary part.- Parameters:
c
-- Returns:
-
complexNum
public static IComplexNum complexNum(double r)
Create a complex numeric number with imaginary part = 0.0- Parameters:
r
- the real part of the number- Returns:
- a complex numeric number with imaginary part = 0.0
-
complexNum
public static IComplexNum complexNum(double r, double i)
Create a complex numeric value- Parameters:
r
- real parti
- imaginary part- Returns:
-
complexNum
public static IComplexNum complexNum(IComplex value)
-
complexNum
public static IComplexNum complexNum(IFraction value)
-
complexNum
public static IComplexNum complexNum(IInteger value)
-
cse
public static IAST cse(IExpr expr)
Perform "common subexpression elimination" (CSE) on an expression.- Parameters:
expr
-- Returns:
- the pair of
{shared-expressions, recursive-replacement-rules}
-
cse
public static IAST cse(IExpr expr, Supplier<String> variablePrefix)
Perform "common subexpression elimination" (CSE) on an expression.- Parameters:
expr
-variablePrefix
- the prefix string, which should be used for the variable names- Returns:
- the pair of
{shared-expressions, recursive-replacement-rules}
-
cseAsJava
public static void cseAsJava(IExpr expr, StringBuilder buf)
Perform "common subexpression elimination" (CSE) on an expression and create Java source code in the givenStringBuilder
.- Parameters:
expr
-buf
-
-
cseAsJava
public static void cseAsJava(IExpr expr, Supplier<String> variablePrefix, StringBuilder buf)
Perform "common subexpression elimination" (CSE) on an expression and create Java source code in the givenStringBuilder
.- Parameters:
expr
-variablePrefix
- the prefix string, which should be used for the variable namesbuf
-
-
CompoundExpression
public static IAST CompoundExpression(IExpr... expr)
Evaluates its arguments in turn, returning the last result.See: CompoundExpression
- Parameters:
expr
- a list of expressions- Returns:
-
function
public static IASTMutable function(IExpr head, IExpr... a)
Create a new abstract syntax tree (AST).- Parameters:
head
- the header symbol of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.a
-- Returns:
-
Condition
public static IAST Condition(IExpr pattern, IExpr test)
Places an additional constraint onpattern
that only allows it to match iftest
evaluates toS.True
.See: Condition
- Parameters:
pattern
-test
-- Returns:
-
Continue
public static IAST Continue()
-
Cuboid
public static IAST Cuboid(IExpr pMin, IExpr pMax)
- Parameters:
pMin
- lower cornerpMax
- upper corner- Returns:
-
D
public static IAST D()
-
DialogReturn
public static IAST DialogReturn()
-
DigitQ
public static IAST DigitQ(IExpr a0)
DigitQ(str)
returns
True
ifstr
is a string which contains only digits.Examples
>> DigitQ("1234") True
-
Dimensions
public static IAST Dimensions(IExpr a0)
Dimensions(expr)
returns a list of the dimensions of the expression
expr
.Examples
A vector of length 3:
>> Dimensions({a, b, c}) = {3}
A 3x2 matrix:
>> Dimensions({{a, b}, {c, d}, {e, f}}) = {3, 2}
Ragged arrays are not taken into account:
>> Dimensions({{a, b}, {b, c}, {c, d, e}}) {3}
The expression can have any head:
>> Dimensions[f[f[a, b, c]]] {1, 3} >> Dimensions({}) {0} >> Dimensions({{}}) {1, 0}
-
Distributed
public static IAST Distributed(IExpr x, IAST distribution)
Create aDistributed(x, <distribution>)
AST.- Parameters:
x
-distribution
-- Returns:
-
div
public static IExpr div(IExpr a, BigInteger i)
-
div
public static IExpr div(BigInteger i, IExpr b)
-
DirectionalLight
public static IASTMutable DirectionalLight(IExpr color, IExpr point)
-
Divide
public static IExpr Divide(IExpr numerator, IExpr denominator)
The divisionnumerator / denominator
will be represented bynumerator * denominator^(-1)
. Ifnumerator.isOne()==true
returndenominator^(-1)
. Ifdenominator.isOne()==true
returnnumerator
.- Parameters:
numerator
- numeratordenominator
- denominator- Returns:
-
Divide
public static IExpr Divide(int numerator, IExpr denominator)
The divisionnumerator / denominator
will be represented bynumerator * denominator^(-1)
. Ifnumerator.isOne()==true
returndenominator^(-1)
. Ifdenominator.isOne()==true
returnnumerator
.- Parameters:
numerator
-denominator
-- Returns:
-
Divide
public static IExpr Divide(IExpr numerator, int denominator)
The divisionnumerator / denominator
will be represented bynumerator * denominator^(-1)
. Ifnumerator.isOne()==true
returndenominator^(-1)
. Ifdenominator.isOne()==true
returnnumerator
.- Parameters:
numerator
-denominator
-- Returns:
-
DivideSides
public static IASTMutable DivideSides(IExpr equationOrInequality)
-
DivideSides
public static IASTMutable DivideSides(IExpr equationOrInequality, IExpr a1)
-
Element
public static IAST Element(IExpr variable, IExpr domain)
Set a domain as an assumption for a variable.- Parameters:
variable
- the variable for which an assumption should be defineddomain
- very often used domains areS.Booleans
,S.Integers
,S.Reals
- Returns:
-
ElementData
public static IAST ElementData(IExpr name, IExpr property)
Property of aname
chemical element.- Parameters:
name
-property
-- Returns:
-
Equal
public static IAST Equal(IExpr lhs, IExpr rhs)
YieldsS.True
iflhs
andrhs
are known to be equal, orS.False
iflhs
andrhs
are known to be unequal.See: Equal
- Parameters:
lhs
-rhs
-- Returns:
-
Equal
public static IAST Equal(IExpr lhs, int rhs)
YieldsS.True
iflhs
andrhs
are known to be equal, orS.False
iflhs
andrhs
are known to be unequal.See: Equal
- Parameters:
lhs
-rhs
-- Returns:
-
eval
public static IExpr eval(IExpr a)
Evaluate an expression. If no evaluation was possible this method returns the given argument.- Parameters:
a
- the expression which should be evaluated- Returns:
- the evaluated expression
- See Also:
EvalEngine.evaluate(IExpr)
-
eval
public static IExpr eval(String str)
Parse and evaluate a string expression.- Parameters:
str
- the string expression which should be parsed and evaluated- Returns:
- the evaluated expression
- See Also:
EvalEngine.evaluate(IExpr)
-
evalExpand
public static IExpr evalExpand(IExpr expr)
EvaluateExpand()
for the given expression. Returns the evaluated expression or the given argument.- Parameters:
expr
- the expression which should be evaluated- Returns:
- the evaluated expression
- See Also:
EvalEngine.evaluate(IExpr)
-
evalExpandAll
public static IExpr evalExpandAll(IExpr a)
ApplyExpandAll()
to the given expression if it's anIAST
. If expanding wasn't possible this method returns the given argument.- Parameters:
a
- the expression which should be evaluated- Returns:
- the evaluated expression
- See Also:
EvalEngine.evaluate(IExpr)
-
evalExpandAll
public static IExpr evalExpandAll(IExpr a, EvalEngine engine)
ApplyExpandAll()
to the given expression if it's anIAST
. If expanding wasn't possible this method returns the given argument.- Parameters:
a
- the expression which should be evaluated- Returns:
- the evaluated expression
- See Also:
EvalEngine.evaluate(IExpr)
-
evaln
@Deprecated public static IExpr evaln(IExpr a0)
Deprecated.useEvalEngine.evalN(IExpr)
insteadEvaluate the given expression in numeric mode- Parameters:
a0
-- Returns:
-
evalQuiet
@Deprecated public static IExpr evalQuiet(IExpr a)
Deprecated.use EvalEngine#evalQuiet();Evaluate an expression in "quiet mode". If no evaluation was possible this method returns the given argument. In "quiet mode" all warnings would be suppressed.- Parameters:
a
- the expression which should be evaluated- Returns:
- the evaluated expression
- See Also:
EvalEngine.evalQuiet(IExpr)
-
evalQuietNull
@Deprecated public static IExpr evalQuietNull(IExpr a)
Deprecated.use EvalEngine#evalQuietNull()Evaluate an expression in "quiet mode". If evaluation is not possible returnnull
. In "quiet mode" all warnings would be suppressed.- Parameters:
a
- the expression which should be evaluated- Returns:
- the evaluated object or
F.NIL
if no evaluation was possible - See Also:
EvalEngine.evalQuietNIL(IExpr)
-
evalTrue
@Deprecated public static boolean evalTrue(IExpr expr)
Deprecated.use EvalEngine#evalTrue()Evaluate the given expression and test if the result equals the symbolTrue
.- Parameters:
expr
-- Returns:
-
EvenQ
public static IAST EvenQ(IExpr x)
EvenQ(x)
returns
True
ifx
is even, andFalse
otherwise.Examples
>> EvenQ(4) True >> EvenQ(-3) False >> EvenQ(n) False
-
ExactNumberQ
public static IAST ExactNumberQ(IExpr expr)
ExactNumberQ(expr)
returns
True
ifexpr
is an exact number, andFalse
otherwise.Examples
>> ExactNumberQ(10) True >> ExactNumberQ(4.0) False >> ExactNumberQ(n) False >> ExactNumberQ(1+I) True >> ExactNumberQ(1 + 1. * I) False
-
expr
public static IReal expr(Number number)
- Parameters:
number
- non-null- Returns:
- scalar with best possible accuracy to encode given number
- Throws:
Exception
- if number is null, or instance of an unsupported type
-
Exp
public static IAST Exp(IExpr z)
The exponential functionE^z
.See: Exp
- Parameters:
z
-- Returns:
-
Exp
public static IAST Exp(int z)
-
expand
public static IExpr expand(IExpr a, boolean expandNegativePowers, boolean distributePlus, boolean evalParts)
ApplyExpand()
to the given expression if it's anIAST
. If expanding wasn't possible this method returns the given argument.- Parameters:
a
- the expression which should be evaluatedexpandNegativePowers
-distributePlus
-evalParts
- evaluate the determined numerator and denominator parts- Returns:
- the evaluated expression
- See Also:
EvalEngine.evaluate(IExpr)
-
Expand
public static IAST Expand(IExpr expr)
Expands out positive rational powers and products of sums inexpr
.See: Expand
- Parameters:
expr
-- Returns:
-
Expand
public static IAST Expand(IExpr expr, IExpr pattern)
Expands out positive rational powers and products of sums inexpr
.See: Expand
- Parameters:
expr
-pattern
-- Returns:
-
expandAll
public static IExpr expandAll(IExpr a, boolean expandNegativePowers, boolean distributePlus)
ApplyExpandAll()
to the given expression if it's anIAST
. If expanding wasn't possible this method returns the given argument.- Parameters:
a
- the expression which should be evaluatedexpandNegativePowers
-distributePlus
-- Returns:
- the evaluated expression
- See Also:
EvalEngine.evaluate(IExpr)
-
Factorial
public static IAST Factorial(int a0)
-
fraction
public static IFraction fraction(org.hipparchus.fraction.BigFraction value)
Create a "fractional" number- Parameters:
value
- the rational value which should be converted to a fractional number- Returns:
- IFraction
-
fraction
public static IFraction fraction(BigInteger numerator, BigInteger denominator)
Create a "fractional" number- Parameters:
numerator
- numerator of the fractional numberdenominator
- denumerator of the fractional number- Returns:
- IFraction
-
fraction
public static IFraction fraction(IInteger numerator, IInteger denominator)
Create a "fractional" number- Parameters:
numerator
- numerator of the fractional numberdenominator
- denumerator of the fractional number- Returns:
- IFraction
-
fraction
public static IRational fraction(long numerator, long denominator)
Create a "fractional" number- Parameters:
numerator
- numerator of the fractional numberdenominator
- denumerator of the fractional number- Returns:
- IFraction
-
fraction
public static IFraction fraction(double value)
Create a "fractional" number from a double number withConfig.DOUBLE_EPSILON
maximum error allowed.- Parameters:
value
- the double value which should be converted to a fractional number
-
fraction
public static IFraction fraction(double value, double epsilon)
Create a "fractional" number from a double number.- Parameters:
value
- the double value which should be converted to a fractional numberepsilon
- maximum error allowed. The resulting fraction is within epsilon of value, in absolute terms
-
fractionConvergent
public static IFraction fractionConvergent(double value)
Create a "fractional" number from a double number.- Parameters:
value
- the double value which should be converted to a fractional number- Returns:
-
fractionExact
public static IExpr fractionExact(double value, boolean attemptNiceFraction)
Create a "fractional" expression that exactly represents the given double number.This methods returns an
IExpr
that, when being evaluated to a double value (usingIExpr.evalf()
), results to the exact same value (per bit) as the given one.Because double values are not exact in all cases but this method returns an exact representation of the given double the results may be unexpected if
attemptNiceFraction = false
. For example for the value0.7
the result is3152519739159347/4503599627370496
and not7/10
as one would actually expect.
When this method is called withattemptNiceFraction=true
it is attempted to compute a result that often meets a human's expectations better and is therefore considered 'nicer'. For example the input0.7
then results in7/10
. The 'nicer' results comes with the cost of an increased runtime. Nevertheless the same requirement regarding an evaluation of the result to the exact same value also applies in this case.While in most cases the returned reference is a
IFraction
, it is not guaranteed for all cases so users should not expect an IFraction.- Parameters:
value
- the double value which should be converted to a fractional numberattemptNiceFraction
- if it should be attempted to compute a 'nicer' fraction- Returns:
- an expression without floating-point numbers that evaluates to the exact same value
- See Also:
AbstractFractionSym.valueOfExact(double)
,AbstractFractionSym.valueOfConvergent(double)
-
Graphics
public static IASTAppendable Graphics()
-
Graphics
public static IASTAppendable Graphics(IExpr graphicPrimitives)
-
Graphics
public static IASTAppendable Graphics(IExpr graphicPrimitives, IAST... optionRules)
-
Graphics3D
public static IASTAppendable Graphics3D(IExpr graphicPrimitives)
-
GumbelDistribution
public static IAST GumbelDistribution()
-
headAST0
public static final IASTMutable headAST0(IExpr head)
Create a new abstract syntax tree (AST).- Parameters:
head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.
-
heaviside
public static IExpr heaviside(IExpr a0, IExpr defaultValue, EvalEngine engine)
-
Hypergeometric1F1Regularized
public static IAST Hypergeometric1F1Regularized(IExpr a0, IExpr a1, IExpr a2)
-
Hypergeometric2F1Regularized
public static IAST Hypergeometric2F1Regularized(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
-
HypergeometricPFQRegularized
public static IAST HypergeometricPFQRegularized(IExpr a0, IExpr a1, IExpr a2)
-
IdentityMatrix
public static IAST IdentityMatrix(int dim)
-
If
public static IAST If(IExpr condition, IExpr trueExpr)
- Parameters:
condition
-trueExpr
-- Returns:
-
If
public static IAST If(IExpr condition, IExpr trueExpr, IExpr falseExpr)
- Parameters:
condition
-trueExpr
-falseExpr
-- Returns:
-
If
public static IAST If(IExpr condition, IExpr trueExpr, IExpr falseExpr, IExpr undefinedExpr)
ReturnstrueExpr
ifcondition
evaluates toS.True
andfalseExpr
if it evaluates toS.False
orundefinedExpr
if condition don't evakluate toS.True
orS.False
.See: If
- Parameters:
condition
-trueExpr
-falseExpr
-- Returns:
-
InexactNumberQ
public static IAST InexactNumberQ(IExpr a)
InexactNumberQ(expr)
returns
True
ifexpr
is not an exact number, andFalse
otherwise.Examples
>> InexactNumberQ(a) False >> InexactNumberQ(3.0) True >> InexactNumberQ(2/3) False
InexactNumberQ
can be applied to complex numbers:>> InexactNumberQ(4.0+I) True
-
initPredefinedPatternSequence
public static IPatternSequence initPredefinedPatternSequence(ISymbol symbol)
-
initPredefinedPatternSequence
public static IPatternSequence initPredefinedPatternSequence(ISymbol symbol, boolean zeroArgsAllowed)
-
initSymbols
public static void initSymbols()
Initialize the complete System
-
integer
@Deprecated public static IInteger integer(BigInteger integerValue)
Deprecated.use ZZ()Create a large integer number.- Parameters:
integerValue
-- Returns:
-
integer
@Deprecated public static IInteger integer(long integerValue)
Deprecated.use ZZ()Create a large integer number.- Parameters:
integerValue
-- Returns:
-
integer
@Deprecated public static IInteger integer(String integerString, int radix)
Deprecated.use ZZ()Create a large integer number.- Parameters:
integerString
- the integer number represented as a Stringradix
- the radix to be used while parsing- Returns:
- Object
-
IntegerQ
public static IAST IntegerQ(IExpr expr)
IntegerQ(expr)
returns
True
ifexpr
is an integer, andFalse
otherwise.Examples
>> IntegerQ(3) 4 >> IntegerQ(Pi) False
-
Integrate
public static IAST Integrate(IExpr f, IExpr x)
Integratesf
with respect tox
. The result does not contain the additive integration constant.See: Integrate
- Parameters:
f
-x
-- Returns:
-
IntervalAlloc
public static IASTAppendable IntervalAlloc(int capacity)
Create a newList
with the givencapacity
.- Parameters:
capacity
- the assumed number of arguments (+ 1 for the header expression is added internally).- Returns:
-
IntervalDataAlloc
public static IASTAppendable IntervalDataAlloc(int capacity)
-
Interval
public static IAST Interval(IExpr list)
Create an "interval" expression:Interval(list)
.- Parameters:
list
-- Returns:
-
Interval
public static IAST Interval(IExpr min, IExpr max)
Create an "interval" expression:Interval(List(from, to))
.- Parameters:
min
- minimum value of the intervalmax
- maximum value of the interval- Returns:
-
IntervalIntersection
public static IAST IntervalIntersection(IExpr... intervals)
IntervalIntersection(interval_1, interval_2, ...) - compute the intersection of the intervals `interval_1, interval_2, ...`
-
IntervalUnion
public static IAST IntervalUnion(IExpr... intervals)
IntervalUnion(interval_1, interval_2, ...) - compute the union of the intervals `interval_1, interval_2, ...`
-
IntervalData
public static IAST IntervalData(IAST list)
Intervals will be represented by objects with head
S.IntervalData
wrapped around a sequence of quadruples of the form, e.g.,{a,Less,LessEqual,b}
representing the half open interval(a,b]
. The empty interval is represented byInterval()
.
-
IntervalData
public static IAST IntervalData(IAST... lists)
Intervals will be represented by objects with head
S.IntervalData
wrapped around a sequence of quadruples of the form, e.g.,{a,Less,LessEqual,b}
representing the half open interval(a,b]
. The empty interval is represented byInterval()
.
-
intIterator
public static IAST intIterator(ISymbol head, Function<IExpr,IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code>.
- Parameters:
head
- the header symbol of the resultfunction
- the function which should be applied on each iterator valuefrom
- from this position (included)to
- to this position (included)step
-- Returns:
-
intIterator
public static IAST intIterator(ISymbol head, IntFunction<IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code>.
- Parameters:
head
- the header symbol of the resultfunction
- the integer function which should be applied on each iterator valuefrom
-to
-step
-- Returns:
-
intIterator
public static IAST intIterator(ISymbol head, Function<IExpr,IExpr> function, IAST list)
-
productRational
public static IRational productRational(IntFunction<IRational> function, int from, int to, int step)
-
sumRational
public static IRational sumRational(IntFunction<IRational> function, int from, int to, int step)
-
InverseBetaRegularized
public static IAST InverseBetaRegularized(IExpr a0, IExpr a1, IExpr a2, IExpr a3)
-
ISet
public static IAST ISet(IExpr lhs, IExpr rhs)
Assign the evaluatedrhs
to thelhs
.
Note: this method returnsF.NIL
.- Parameters:
lhs
- left-hand-side of the assignmentrhs
- right-hand-side of the assignment- Returns:
F.NIL
-
ISetDelayed
public static IAST ISetDelayed(IExpr lhs, IExpr rhs)
Assign the unevaluatedrhs
to thelhs
.
Note: this method returnsNIL
.- Parameters:
lhs
- left-hand-side of the assignmentrhs
- right-hand-side of the assignment- Returns:
NIL
-
isNumEqualInteger
public static boolean isNumEqualInteger(double value, IInteger ii) throws ArithmeticException
- Throws:
ArithmeticException
-
isNumEqualRational
public static boolean isNumEqualRational(double value, IRational rational) throws ArithmeticException
Test ifrational.doubleValue()
equalsvalue
within the toleranceConfig.DOUBLE_TOLERANCE
.- Parameters:
value
-rational
-- Returns:
- Throws:
ArithmeticException
-
isNumIntValue
public static boolean isNumIntValue(double value)
Test if the value is a Javaint
value within the toleranceConfig.DOUBLE_TOLERANCE
.- Parameters:
value
-- Returns:
-
isNumIntValue
public static boolean isNumIntValue(double value, double epsilon)
Test if the value is a Javaint
value within the given toleranceepsilon
.- Parameters:
value
-epsilon
- the tolerance- Returns:
-
isNumIntValue
public static boolean isNumIntValue(double value, int i)
-
isEqual
public static final boolean isEqual(double x, double y)
Check difference is less than a constantinfinity == infinity returns true eg 1/0
-infinity == infinity returns false eg -1/0
-infinity == -infinity returns true
undefined == undefined returns false eg 0/0
- Returns:
- whether x is equal to y
-
isEqual
public static final boolean isEqual(org.hipparchus.complex.Complex x, org.hipparchus.complex.Complex y)
-
isFuzzyEquals
public static boolean isFuzzyEquals(double a, double b, double tolerance)
Returnstrue
ifa
andb
are withintolerance
(exclusive) of each other.Technically speaking, this is equivalent to
Math.abs(a - b) <= tolerance || Double.valueOf(a).equals(Double.valueOf(b))
.Notable special cases include:
- All NaNs are fuzzily equal.
- If
a == b
, thena
andb
are always fuzzily equal. - Positive and negative zero are always fuzzily equal.
- If
tolerance
is zero, and neithera
norb
is NaN, thena
andb
are fuzzily equal if and only ifa == b
. - With
Double.POSITIVE_INFINITY
tolerance, all non-NaN values are fuzzily equal. - With finite tolerance,
Double.POSITIVE_INFINITY
andDouble.NEGATIVE_INFINITY
are fuzzily equal only to themselves.
This is reflexive and symmetric, but not transitive, so it is not an equivalence relation and not suitable for use in
Object.equals(java.lang.Object)
implementations.- Throws:
IllegalArgumentException
- iftolerance
is< 0
or NaN
-
isFuzzyEquals
public static final boolean isFuzzyEquals(org.hipparchus.complex.Complex x, org.hipparchus.complex.Complex y, double tolerance)
-
isAlmostSame
public static boolean isAlmostSame(double a, double b)
Test ifa
andb
are almost the same values by comparing theDouble.doubleToLongBits(double)
values.See also the implementation of
Double.compare(double, double)
- Parameters:
a
-b
-
-
relativeDifference
public static double relativeDifference(double x, double y)
Calculate the relative difference between x and y. In case |x+y|/2 is zero the absolute difference is returned.- Parameters:
x
- first valuey
- second value- Returns:
- relative error
-
isZero
public static boolean isZero(double value)
Test if the absolute value is lessConfig.DOUBLE_EPSILON
.- Parameters:
value
-- Returns:
-
isZero
public static boolean isZero(org.hipparchus.complex.Complex value)
Test if the absolute value is lessConfig.MACHINE_EPSILON
.- Parameters:
value
-- Returns:
-
isZero
public static boolean isZero(double x, double epsilon)
Test if the absolute value is less than the given epsilon.- Parameters:
x
-epsilon
-- Returns:
-
isZero
public static boolean isZero(org.hipparchus.complex.Complex x, double epsilon)
Test if the absolute value is lessConfig.MACHINE_EPSILON
.- Parameters:
x
-epsilon
-- Returns:
-
isZero
public static boolean isZero(org.apfloat.Apfloat x, double epsilon)
-
isZero
public static boolean isZero(org.apfloat.Apfloat x, org.apfloat.Apfloat epsilon)
-
isZero
public static boolean isZero(org.apfloat.Apcomplex x, double epsilon)
-
isZero
public static boolean isZero(org.apfloat.Apcomplex x, org.apfloat.Apfloat epsilon)
-
JSFormData
public static IAST JSFormData(String plainJavaScript, String format)
Create JavaScript form data in the given format.- Parameters:
plainJavaScript
-format
-- Returns:
-
LessEqual
public static IAST LessEqual(IExpr x1, IExpr x2, IExpr x3)
YieldsS.True
ifx1
is known to be less equal thanx2
andx2
is known to be less equal thanx3
.See: LessEqual
- Parameters:
x1
-x2
-x3
-- Returns:
-
Line
public static IASTAppendable Line()
-
allocLevel1
public static int allocLevel1(IAST ast, Predicate<IExpr> predicate)
Calulate the allocation size for a newIAST
object. Ifpredicate#test()
returnstrue
add the argumentsIAST.argSize()
to theast.argSize()
- Parameters:
ast
-predicate
-- Returns:
-
allocMin8
public static int allocMin8(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 7- Parameters:
ast
-- Returns:
-
allocMin8
public static int allocMin8(int size)
Determine the minimum of thesize
and integer number 7- Parameters:
size
-- Returns:
-
allocMin16
public static int allocMin16(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 15- Parameters:
ast
-- Returns:
-
allocMin16
public static int allocMin16(int size)
Determine the minimum of thesize
and integer number 15- Parameters:
size
-- Returns:
-
allocMin32
public static int allocMin32(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 31,- Parameters:
ast
-- Returns:
-
allocMin32
public static int allocMin32(int size)
Determine the minimum of thesize
and integer number 31- Parameters:
size
-- Returns:
-
allocMin64
public static int allocMin64(IAST ast)
Determine the minimum of theast
IAST.argSize()
and integer number 63,- Parameters:
ast
-- Returns:
-
allocMax8
public static int allocMax8(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 7,- Parameters:
ast
-- Returns:
-
allocMax16
public static int allocMax16(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 15,- Parameters:
ast
-- Returns:
-
allocMax32
public static int allocMax32(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 31,- Parameters:
ast
-- Returns:
-
allocMax64
public static int allocMax64(IAST ast)
Determine the maximum of theast
IAST.argSize()
and integer number 63,- Parameters:
ast
-- Returns:
-
ListAlloc
public static IASTAppendable ListAlloc()
Create an appendable list{ }
.- Returns:
-
ListAlloc
public static IASTAppendable ListAlloc(int initialCapacity)
Create a newList
with the giveninitial capacity
.- Parameters:
initialCapacity
- the assumed number of arguments (+ 1 for the header expression is added internally).- Returns:
-
ListAlloc
public static IASTAppendable ListAlloc(Collection<? extends IExpr> collection)
Create a newList
with the capacitycollection.size()
and append the elements of the collection.- Parameters:
collection
- the collection which holds the elements which should be appended- Returns:
-
ListAlloc
public static IASTAppendable ListAlloc(Collection<? extends IExpr> collection, int capacity)
Create a newList
with the capacitycollection.size() + capacity
and append the elements of the collection.- Parameters:
collection
-capacity
-- Returns:
-
ListAlloc
public static IASTAppendable ListAlloc(IExpr... a)
Create an appendable list{ }
.- Parameters:
a
-- Returns:
-
ListAlloc
public static IASTAppendable ListAlloc(Stream<? extends IExpr> stream)
Constructs a list that holds the expressions of the input stream.for instance,
- if the stream consists of
IReal
s, the return value represents a vector, - if the stream consists of vectors, the return value represents a matrix.
- if the stream consists of matrices, the return value represents a tensor with rank 3.
- etc.
- Parameters:
stream
- of expressions to form the first level of the return value- Returns:
- list that holds the expressions of the input stream
- if the stream consists of
-
ListAlloc
public static IASTAppendable ListAlloc(IntStream stream)
-
tensorList
public static IAST tensorList(int n, Integer... numbers)
For positive n, add the first n elements ofnumbers
to the list.For negative n, add the last n elements ofnumbers
to the list.- Parameters:
n
-numbers
-- Returns:
-
List
public static IASTMutable List(double... numbers)
-
List
public static IASTMutable List(String... strs)
-
List
public static IAST List()
Create an empty immutable list{ }
(i.e.List()
).- Returns:
-
listOfObjects
public static IAST listOfObjects(Object... objects)
- Parameters:
objects
- the objects which should be converted, before adding them to the list- Returns:
- a
List(...)
of expressions
-
list
public static IAST list(IExpr expr)
Return a single value as aList()
- Parameters:
expr
-- Returns:
-
list
public static IAST list(IExpr x1, IExpr x2)
Return a pair of values as aList()
- Parameters:
x1
-x2
-- Returns:
-
pair
public static Pair pair(IExpr x1, IExpr x2)
Return a pair of values as aList()
- Parameters:
x1
-x2
-- Returns:
-
list
public static IAST list(IExpr x1, IExpr x2, IExpr x3)
Return a triple of values as aList()
- Parameters:
x1
-x2
-x3
-- Returns:
-
List
public static IAST List(long... numbers)
-
List
public static IASTMutable List(int... numbers)
-
ListQ
public static IAST ListQ(IExpr a)
ListQ(expr)
tests whether
expr
is aList
.Examples
>> ListQ({1, 2, 3}) True >> ListQ({{1, 2}, {3, 4}}) True >> ListQ(x) False
-
Literal
@Deprecated public static IAST Literal(IExpr a0)
Deprecated.use HoldPattern- Parameters:
a0
-- Returns:
-
Log
public static IAST Log(IExpr z)
Returns the natural logarithm ofz
.See: Log
- Parameters:
z
-- Returns:
-
Log
public static IAST Log(int z)
Returns the natural logarithm ofz
.- Parameters:
z
-- Returns:
-
Log
public static IAST Log(IExpr z, int base)
Returns the logarithm ofz
for thebase
.- Parameters:
z
-base
-- Returns:
-
Log
public static IAST Log(int z, int base)
Returns the logarithm ofz
for thebase
.- Parameters:
z
-base
-- Returns:
-
MachineNumberQ
public static IAST MachineNumberQ(IExpr a0)
MachineNumberQ(expr)
returns
True
ifexpr
is a machine-precision real or complex number.Examples
>> MachineNumberQ(3.14159265358979324) False >> MachineNumberQ(1.5 + 2.3*I) True >> MachineNumberQ(2.71828182845904524 + 3.14159265358979324*I) False >> MachineNumberQ(1.5 + 3.14159265358979324*I) True >> MachineNumberQ(1.5 + 5 *I) True
-
mapFunction
public static IASTAppendable mapFunction(IExpr head, IAST ast)
-
mapFunction
public static <T extends IExpr> IASTAppendable mapFunction(IExpr head, IAST ast, Function<T,IExpr> function)
Iterates over theast
elements and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnF.NIL
.- Parameters:
head
- the head of the result astast
-function
-- Returns:
NIL
if the function returnsnull
-
mapFunction
public static <T extends IExpr> IASTAppendable mapFunction(IExpr head, IAST ast, Function<T,IExpr> function, Predicate<T> predicate)
-
mapFunction
public static <T extends IExpr> IASTAppendable mapFunction(IExpr head, IAST ast, int start, int end, Function<T,IExpr> function)
- Parameters:
head
- the head of the result astast
-start
- start of the range (inclusive) of elements which should be mappedend
- end of the range (exclusive) of elements which should be mappedfunction
-- Returns:
-
mapFunction
public static <T extends IExpr> IASTAppendable mapFunction(IExpr head, IAST ast, int start, int end, Function<T,IExpr> function, Predicate<T> predicate)
- Parameters:
head
- the head of the result astast
-start
- start of the range (inclusive) of elements which should be mappedend
- end of the range (exclusive) of elements which should be mappedfunction
-predicate
-- Returns:
-
mapFunction
public static IASTAppendable mapFunction(IExpr head, IAST ast, ObjIntFunction<IExpr,IExpr> function)
Iterates over the lists elements and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnfalse
.- Parameters:
ast
-function
-- Returns:
NIL
if the function returnsnull
-
mapFunction
public static <T> IASTAppendable mapFunction(IExpr head, List<T> list, Function<T,IExpr> function)
Iterates over the lists elements and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnfalse
.- Parameters:
list
-function
-- Returns:
NIL
if the function returnsnull
-
mapFunction
public static <T> IASTAppendable mapFunction(IExpr head, List<T> list, Function<T,IExpr> function, Predicate<T> predicate)
-
mapList
public static <T extends IExpr> IASTAppendable mapList(IAST ast, Function<T,IExpr> function)
Iterates over the lists elements and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnfalse
.- Parameters:
ast
-function
-- Returns:
NIL
if the function returnsnull
-
mapList
public static <T extends IExpr> IASTAppendable mapList(IAST ast, Function<T,IExpr> function, Predicate<T> predicate)
-
mapList
public static IASTAppendable mapList(IAST ast, ObjIntFunction<IExpr,IExpr> function)
Iterates over the lists elements and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnfalse
.- Parameters:
ast
-function
-- Returns:
NIL
if the function returnsnull
-
mapList
public static <T extends IExpr> IASTAppendable mapList(List<T> list, Function<T,IExpr> function)
Iterates over the lists elements and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnfalse
.- Parameters:
list
-function
-- Returns:
NIL
if the function returnsnull
-
mapList
public static IASTAppendable mapList(List<IExpr> list, Function<IExpr,IExpr> function, Predicate<IExpr> predicate)
-
mapSet
public static IASTAppendable mapSet(Set<? extends IExpr> exprSet, Function<IExpr,IExpr> function)
Iterates over the set elements and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnfalse
.- Parameters:
exprSet
-function
-- Returns:
NIL
if the function returnsnull
-
mapMap
public static IASTAppendable mapMap(Map<? extends IExpr,? extends IExpr> map, BiFunction<IExpr,IExpr,IExpr> biFunction)
Iterates over the maps (key, value) pairs and calls the function. Append the functions result expression at the end of the result list, if the function results is not equalNIL
. If the function results isnull
stop iterating and returnfalse
.- Parameters:
map
-biFunction
-- Returns:
NIL
if the biFunction returnsnull
-
mapRange
public static <T extends IExpr> IASTAppendable mapRange(int iMin, int iMax, IntFunction<T> function)
Create an integer range betweeniMin
(inclusive) andiMax
(exclusive) and call the function with the elements of the created range. Append the result of thefunction
to the returned result list.If it's equalNIL
then don't appending an entry. If it's equalnull
then returnNIL
for this method.- Parameters:
iMin
- minimum range limit (inclusive)iMax
- maximum range limit (exclusive)function
- function thoseapply(x)
method will be called with each number in the range. If theapply
method returnsnull
then returnNIL
.- Returns:
-
mapRange
public static <T extends IExpr> IASTAppendable mapRange(IExpr head, int iMin, int iMax, IntFunction<T> function)
Create an integer range betweeniMin
(inclusive) andiMax
(exclusive) and call the function with the elements of the created range. Append the result of thefunction
to the returned resultast
. If it's equalNIL
then don't appending an entry. If it's equalnull
then returnNIL
for this method.- Parameters:
head
- the new head of the resultast
iMin
- minimum range limit (inclusive)iMax
- maximum range limit (exclusive)function
- thoseapply(x)
method will be called with each number in the range. If theapply
method returnsnull
then returnNIL
.- Returns:
-
Max
public static IASTAppendable Max()
-
Min
public static IASTAppendable Min()
-
minus
public static IExpr minus(IExpr a, BigInteger i)
-
minus
public static IExpr minus(BigInteger i, IExpr b)
-
MissingQ
public static IAST MissingQ(IExpr a0)
MissingQ(expr)
returns
True
ifexpr
is aMissing()
expression.Examples
>> MissingQ(Missing("Test message")) True
-
mod
public static IExpr mod(IExpr a, BigInteger i)
-
mod
public static IExpr mod(BigInteger i, IExpr b)
-
Module
public static IAST Module(IExpr listOfLocalVariables, IExpr expr)
Evaluatesexpr
for thelistOfLocalVariables
by first renaming the local variables inexpr
.See: Module
- Parameters:
listOfLocalVariables
-expr
-- Returns:
-
multiply
public static IExpr multiply(IExpr a, BigInteger i)
-
multiply
public static IExpr multiply(BigInteger i, IExpr b)
-
MultiplySides
public static IASTMutable MultiplySides(IExpr equationOrInequality, IExpr x)
-
N
public static IAST N(IExpr symbolicExpr)
Evaluate the given (symbolic) expression in numeric mode.- Parameters:
symbolicExpr
-- Returns:
-
N
public static IAST N(IExpr symbolicExpr, IExpr precision)
Evaluate the given (symbolic) expression in numeric mode withprecision
digits .- Parameters:
symbolicExpr
-precision
-- Returns:
-
Negate
public static IExpr Negate(IExpr x)
Multiplies the given argument by-1
. TheIExpr#negate()
method does evaluations, which don't agree with pattern matching assumptions (in left-hand-sides expressions). so it is only called forINumber
objects, otherwise aTimes(CN1, x)
AST would be created.- Parameters:
x
- the expression which should be negated.- Returns:
-
newInstance
public static IAST newInstance(int intialArgumentsCapacity, IExpr head)
Create a new abstract syntax tree (AST).- Parameters:
intialArgumentsCapacity
- the initial capacity of arguments of the AST.head
- the header expression of the function. If the ast represents a function likef[x,y], Sin[x],...
, thehead
will be an instance of type ISymbol.- Returns:
-
NormalDistribution
public static IAST NormalDistribution()
-
Not
public static IAST Not(IExpr expr)
Logical Not function (negation). ReturnsS.True
ifexpr
isS.False
. ReturnsS.False
ifexpr
isS.True
.See: Not
- Parameters:
expr
-- Returns:
-
num
public static INum num(org.apfloat.Apfloat af)
Return aApfloatNum
which wraps aApfloat
arbitrary precision floating-point number.- Parameters:
af
-- Returns:
-
num
public static INum num(String valueString)
Create a numeric value from the input string. IfEvalEngine.isArbitraryMode()
istrue
return aApfloatNum
which wraps aApfloat
arbitrary precision floating-point number with the engines precision.- Parameters:
valueString
- the numeric value represented as a string.- Returns:
-
num
public static INum num(String numberStr, long precision)
Return aApfloatNum
which wraps aApfloat
arbitrary precision floating-point number.- Parameters:
numberStr
-precision
-- Returns:
- a
ApfloatNum
which wraps aApfloat
Arbitrary precision floating-point number.
-
num
public static Num num(double value)
Return aNum
which wraps a Java double number.- Parameters:
value
-- Returns:
-
NumberQ
public static IAST NumberQ(IExpr a0)
NumberQ(expr)
returns
True
ifexpr
is an explicit number, andFalse
otherwise.Examples
>> NumberQ(3+I) True >> NumberQ(5!) True >> NumberQ(Pi) False
-
NumericQ
public static IAST NumericQ(IExpr a0)
NumericQ(expr)
returns
True
ifexpr
is an explicit numeric expression, andFalse
otherwise.Examples
>> NumericQ(E+Pi) True >> NumericQ(Sqrt(3)) True
-
OddQ
public static IAST OddQ(IExpr x)
OddQ(x)
returns
True
ifx
is odd, andFalse
otherwise.Examples
>> OddQ(-3) True >> OddQ(0) False
-
Or
public static IASTAppendable Or()
-
Or
public static IAST Or(IExpr expr1, IExpr expr2)
expr1 || expr2
evaluates each expression in turn, returningS.True
as soon as an expression evaluates toS.True
. If all expressions evaluate toS.False
, it returnsS.False
.See: Or
- Parameters:
expr1
-expr2
-- Returns:
-
Or
public static IAST Or(IExpr expr1, IExpr expr2, IExpr expr3)
expr1 || expr2 || expr3
evaluates each expression in turn, returningS.True
as soon as an expression evaluates toS.True
. If all expressions evaluate toS.False
, it returnsS.False
.See: Or
- Parameters:
expr1
-expr2
-expr3
-- Returns:
-
Out
public static IAST Out(int n)
-
Overflow
public static IAST Overflow()
-
Part
public static IASTAppendable Part()
See: Part
-
Part
public static IASTAppendable Part(IExpr... a)
See: Part
-
Part
public static IASTAppendable Part(int extraSize, IExpr... a)
See: Part
-
PatternTest
public static IAST PatternTest(IExpr pattern, IExpr test)
Constrainspattern
to matchexpr
only if the evaluation oftest(expr)
yieldsS.True
.See: PatternTest
- Parameters:
pattern
-test
-- Returns:
-
PiecewiseExpand
public static IAST PiecewiseExpand(IExpr expr)
See: PiecewiseExpand
-
plus
public static IExpr plus(IExpr a, BigInteger i)
-
plus
public static IExpr plus(BigInteger i, IExpr b)
-
Plus
public static IASTAppendable Plus()
See: Plus
-
PlusAlloc
public static IASTAppendable PlusAlloc(int initialCapacity)
See: Plus- Parameters:
initialCapacity
- the initialCapacity of this AST- Returns:
-
Plus
public static IASTAppendable Plus(IExpr a0)
See: Plus
-
PolynomialQ
public static IAST PolynomialQ(IExpr expr, IExpr variable)
ReturnS.True
ifexpr
is a polynomial for thevariable
. ReturnS.False
in all other cases.See: PolynomialQ
- Parameters:
expr
-variable
-- Returns:
-
PolynomialQuotientRemainder
public static IAST PolynomialQuotientRemainder(IExpr poly1, IExpr poly2, IExpr x)
-
PointSize
public static IAST PointSize(double value)
-
Power
public static IExpr Power(IExpr base, long exponent)
Define a power expressionbase ^ exponent
.See: Power
- Parameters:
base
-exponent
-- Returns:
-
predefinedSymbol
public static ISymbol predefinedSymbol(String symbolName)
Create a "predefined" symbol for constants or function names.- Parameters:
symbolName
-- Returns:
-
Product
public static IAST Product(IExpr expr, IExpr iterationSpecification)
- Parameters:
expr
- expression which should be multiplied upiterationSpecification
- a standard iteration specification- Returns:
Product(expr, iterationSpecification)
AST
-
product
public static IExpr product(Function<IInteger,IExpr> function, int from, int to)
Iterate over an integer rangefrom <= i <= to
and create a product of the created values.- Parameters:
function
- the function which should be applied on each iterator valuefrom
-to
-- Returns:
-
QQ
public static IFraction QQ(org.hipparchus.fraction.BigFraction frac)
Create a "fractional" number from a HipparchusBigFraction
number.- Parameters:
frac
- a big fractional number- Returns:
- IFraction
-
QQ
public static IFraction QQ(IInteger numerator, IInteger denominator)
Create a "fractional" numbernumerator / denominator
- Parameters:
numerator
- numerator of the fractional numberdenominator
- denominator of the fractional number- Returns:
- IFraction
-
QQ
public static IFraction QQ(long numerator, long denominator)
Create a "fractional" numbernumerator / denominator
- Parameters:
numerator
- numerator of the fractional numberdenominator
- denominator of the fractional number- Returns:
- IFraction
-
quaternary
public static final IASTAppendable quaternary(IExpr head, IExpr a0, IExpr a1, IExpr a2, IExpr a3)
-
Quantile
public static IAST Quantile(IExpr distribution)
Returns the Quantile of thedistribution
.See: Quantile
- Parameters:
distribution
-- Returns:
-
Quantile
public static IAST Quantile(IExpr list, IExpr q, IExpr definition)
Returns theq
-Quantile oflist
with the given quantiledefinition
. The default parameters for the quantile definition are{{0,0},{1,0}}
.See: Quantile
- Parameters:
list
-q
-- Returns:
-
Quantity
public static IAST Quantity(IExpr magnitude, IExpr unit)
- Parameters:
magnitude
-unit
-- Returns:
-
QuantityMagnitude
public static IAST QuantityMagnitude(IExpr quantity)
Returns the value of thequantity
.See: QuantityMagnitude
- Parameters:
quantity
-- Returns:
-
QuantityMagnitude
public static IAST QuantityMagnitude(IExpr quantity, IExpr unit)
- Parameters:
quantity
-unit
-- Returns:
-
quinary
public static final IASTMutable quinary(IExpr head, IExpr a0, IExpr a1, IExpr a2, IExpr a3, IExpr a4)
-
reduce
public static IExpr reduce(IAST ast, int startInclusive, int endExclusive, IExpr identity, BinaryOperator<IExpr> accumulator)
Performs a reduction on the elements of this function range, using the provided identity value and an associative accumulation function, and returns the reduced value. This is equivalent to:IExpr result = identity; for (int i = startInclusive; i < endExclusive; i++) { IExpr element = ast.getRule(i); result = accumulator.apply(result, element); } return result;
- Parameters:
ast
-startInclusive
- the first index to cover, inclusiveendExclusive
- index immediately past the last index to coveridentity
- the identity value for the accumulating functionaccumulator
- an associative, non-interfering, stateless function for combining two values- Returns:
-
Reduce
public static IAST Reduce(IExpr logicExpr, IExpr variable)
Reduce(logic-expression, var) - returns the reduced `logic-expression` for the variable `var`. Reduce works only for the `Reals` domain.- See Also:
- Reduce documentation
-
RGBColor
public static IAST RGBColor(double red, double green, double blue)
-
symbol
public static ISymbol symbol(String symbolName)
Get or create a user defined symbol which is retrieved from the evaluation engines context path.- Parameters:
symbolName
- the name of the symbol- Returns:
- the symbol object from the context path
-
symbol
public static ISymbol symbol(String symbolName, EvalEngine engine)
Get or create a user defined symbol which is retrieved from the evaluation engines context path.- Parameters:
symbolName
- the name of the symbolengine
- the evaluation engine- Returns:
- the symbol object from the context path
-
symbol
public static ISymbol symbol(String symbolName, IAST assumptionAST)
Get or create a user defined symbol which is retrieved from the evaluation engines context path. Additional set assumptions to the engines global assumptions. Use#1
orSlot1
in theassumptionAST
expression for this symbol.- Parameters:
symbolName
- the name of the symbolassumptionAST
- the assumptions which should be set for the symbol. Use#1
orSlot1
in theassumptionAST
expression for this symbol.- Returns:
- the symbol object from the context path
-
symbol
public static ISymbol symbol(String symbolName, IAST assumptionAST, EvalEngine engine)
Get or create a user defined symbol which is retrieved from the evaluation engines context path. Additional set assumptions to the engines global assumptions. Use#1
orSlot1
in theassumptionAST
expression for this symbol.- Parameters:
symbolName
- the name of the symbolassumptionAST
- the assumptions which should be set for the symbol. Use#1
orSlot1
in theassumptionAST
expression for this symbol.engine
- the evaluation engine- Returns:
- the symbol object from the context path
-
hasSymbol
public static boolean hasSymbol(String symbolName, EvalEngine engine)
Test if thesymbolName
is defined in the one of the contexts available on the context path.- Parameters:
symbolName
- the name of a symbolengine
-- Returns:
-
symbol
public static ISymbol symbol(String symbolName, String contextStr, IAST assumptionAST, EvalEngine engine)
-
symbol
public static ISymbol symbol(Context context, String symbolName, EvalEngine engine)
-
usage
public static final String usage(ISymbol head)
Print the documentation for the given symbol.- Parameters:
head
-- Returns:
-
usage
public static final String usage(String symbolName)
Print the documentation for the given symbol name.- Parameters:
symbolName
-- Returns:
-
Dummy
public static ISymbol Dummy(char symbolName)
Create a unique dummy symbol which is retrieved from the evaluation engines DUMMY context. A "Dummy" symbol is not known in string parsing.- Parameters:
symbolName
- the name of the symbol- Returns:
- the symbol object from the context path
- See Also:
symbol(String)
-
Dummy
public static ISymbol Dummy(String symbolName)
Create a unique dummy symbol which is retrieved from the evaluation engines DUMMY context. A "Dummy" symbol is not known in string parsing.- Parameters:
symbolName
- the name of the symbol- Returns:
- the symbol object from the context path
- See Also:
symbol(String)
-
Dummy
public static ISymbol Dummy()
Create a unique dummy symbol with prefix "$", which is retrieved from the evaluation engines DUMMY context. A "Dummy" symbol is not known in string parsing.- Returns:
- the symbol object from the context path
-
localBiFunction
public static IBuiltInSymbol localBiFunction(String symbolName, BinaryOperator<IExpr> function)
-
localFunction
public static IBuiltInSymbol localFunction(String symbolName, UnaryOperator<IExpr> function)
-
localFunction
public static IBuiltInSymbol localFunction(String symbolName, IEvaluator evaluator)
-
localBiPredicate
public static IBuiltInSymbol localBiPredicate(String symbolName, BiPredicate<IExpr,IExpr> function)
-
localPredicate
public static IBuiltInSymbol localPredicate(String symbolName, Predicate<IExpr> function)
-
removeUserSymbol
public static ISymbol removeUserSymbol(String symbolName)
Remove a user-defined symbol from the eval engines context path. Doesn't remove predefined names from the System Context.- Parameters:
symbolName
- the name of the symbol- Returns:
- the removed symbol or
null
if no symbol was found
-
senary
public static final IAST senary(IExpr head, IExpr a0, IExpr a1, IExpr a2, IExpr a3, IExpr a4, IExpr a5)
-
Sequence
public static IASTAppendable Sequence()
-
Sequence
public static IASTMutable Sequence(int... numbers)
-
Slot
public static IAST Slot(int i)
-
SlotSequence
public static IAST SlotSequence(int i)
-
solve
public static IExpr[] solve(IAST equations, ISymbol variable)
Solve an equation for a single variable.Solve
100-x==0
for variablex
ISymbol x = F.Dummy(engine); IExpr[] solutions = F.solve(F.Equal(F.Subtract(F.ZZ(100), x), F.C0), x);
See Solve- Parameters:
equations
- one single equation or a list of equations.variable
-- Returns:
-
Sqr
public static IAST Sqr(IExpr x)
Create a "square" expression:Power(x, 2)
.- Parameters:
x
-- Returns:
-
Sqrt
public static IAST Sqrt(IExpr x)
Create a "square root" expression:Power(x, 1/2)
.See: Sqrt
- Parameters:
x
-- Returns:
-
Sqrt
public static IAST Sqrt(int n)
Create a "square root" expression:Power(n, 1/2)
.See: Sqrt
- Parameters:
n
-- Returns:
-
stringx
public static final IStringX stringx(char c)
Create a Symja string expression with mime type TEXT_PLAIN.- Parameters:
c
-- Returns:
- See Also:
IStringX.TEXT_PLAIN
-
stringx
public static final IStringX stringx(String str)
Create a Symja string expression with mime type TEXT_PLAIN.- Parameters:
str
-- Returns:
- See Also:
IStringX.TEXT_PLAIN
-
stringx
public static final IStringX stringx(String str, short mimeType)
reate a Symja string expression.- Parameters:
str
-mimeType
- the mime type of the string- Returns:
- See Also:
IStringX.TEXT_PLAIN
,IStringX.TEXT_LATEX
,IStringX.TEXT_MATHML
,IStringX.TEXT_HTML
-
stringx
public static final IStringX stringx(StringBuilder str)
Create a string expression- Parameters:
str
-- Returns:
-
subdivide
public static IAST subdivide(int n)
Create a list{0, 1/n,2/n,3/n,...,n}
.- Parameters:
n
- the number of the "elements of the result list" minus 1- Returns:
- a list
{0, 1/n,2/n,3/n,...,n}
-
subdivide
public static IAST subdivide(int xMax, int n)
Create a list by dividing the range0
toxMax
inton
parts.- Parameters:
xMax
- end of range (inclusive)n
- the number of the "elements of the result list" minus 1- Returns:
-
subdivide
public static IAST subdivide(int xMin, int xMax, int n)
Create a list by dividing the rangexMin
toxMax
inton
parts.- Parameters:
xMin
- start of range (inclusive)xMax
- end of range (inclusive)n
- the number of the "elements of the result list" minus 1- Returns:
-
subdivide
public static ASTRealVector subdivide(double xMax, int n)
Create a list by dividing the range0
toxMax
inton
parts.- Parameters:
xMax
- end of range (inclusive)n
- the number of the "elements of the result list" minus 1- Returns:
-
subdivide
public static ASTRealVector subdivide(double xMin, double xMax, int n)
Create a list by dividing the rangexMin
toxMax
inton
parts.- Parameters:
xMin
- start of range (inclusive)xMax
- end of range (inclusive)n
- the number of the "elements of the result list" minus 1- Returns:
-
subs
public static IExpr subs(IExpr expr, IExpr x, IExpr y)
Substitute all (sub-) expressionsx
inexpr
withy
. If no substitution matches, the method returns the givenexpr
.- Parameters:
expr
- the complete expresssionx
- the subexpression which should be replacedy
- the expression which replacesx
- Returns:
- the input
expr
if no substitution of a (sub-)expression was possible or the substituted expression.
-
subsList
public static IExpr subsList(IExpr expr, Map<? extends IExpr,? extends IExpr> map)
Substitute all (sub-) expressions contained as keys inmap
inexpr
with the corresponding value inmap
. If no substitution matches, the method returns the givenexpr
.- Parameters:
expr
-- Returns:
-
subst
public static IExpr subst(IExpr expr, Function<IExpr,IExpr> function)
Substitute all (sub-) expressions with the given unary function. If no substitution matches, the method returns the givenexpr
.- Parameters:
expr
-function
- if the unary functionsapply()
method returnsF.NIL
the expression isn't substituted.- Returns:
- the input
expr
if no substitution of a (sub-)expression was possible or the substituted expression.
-
subst
public static IExpr subst(IExpr expr, Map<? extends IExpr,? extends IExpr> map)
Substitute all (sub-) expressions with the given map. If no substitution matches, the method returns the givenexpr
.- Parameters:
expr
-map
- if the mapsget()
method returnsnull
the expression isn't substituted.- Returns:
- the input
expr
if no substitution of a (sub-)expression was possible or the substituted expression.
-
subst
public static IExpr subst(IExpr expr, IAST astRules)
Substitute all (sub-) expressions with the given rule set. If no substitution matches, the method returns the givenexpr
.- Parameters:
expr
-astRules
- rules of the formx->y
or{a->b, c->d}
; the left-hand-side of the rule can contain pattern objects.- Returns:
- the input
expr
if no substitution of a (sub-)expression was possible or the substituted expression.
-
subst
public static IExpr subst(IExpr expr, IExpr subExpr, IExpr replacementExpr)
Substitute all (sub-) expressions with the given replacement expression. If no (sub-) expression matches, the method returns the givenexpr
.- Parameters:
expr
-subExpr
-replacementExpr
-- Returns:
- the input
expr
if no substitution of a (sub-)expression was possible or the substituted expression.
-
Subtract
public static IAST Subtract(IExpr x, IExpr y)
Returnx + (-1)*y
- Parameters:
x
-y
-- Returns:
-
Subtract
public static IAST Subtract(IExpr x, int y)
Returnx + (-1)*y
- Parameters:
x
-y
-- Returns:
-
SubtractSides
public static IASTMutable SubtractSides(IExpr equationOrInequality)
-
SubtractSides
public static IASTMutable SubtractSides(IExpr equationOrInequality, IExpr x)
-
Sum
public static IAST Sum(IExpr expr, IExpr iterationSpecification)
- Parameters:
expr
- expression which should be summed upiterationSpecification
- a standard iteration specification- Returns:
Sum(expr, iterationSpecification)
AST
-
Sum
public static IAST Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2)
-
Sum
public static IAST Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2, IExpr iterationSpecification3)
-
Sum
public static IAST Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2, IExpr iterationSpecification3, IExpr iterationSpecification4)
-
Sum
public static IAST Sum(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2, IExpr iterationSpecification3, IExpr iterationSpecification4, IExpr iterationSpecification5)
-
sumRational
public static IRational sumRational(IntFunction<IRational> function, int iMin, int iMax)
-
sum
public static IExpr sum(Function<IInteger,IExpr> function, int iMin, int iMax)
Evaluate the sum fromiMin
toiMax
and step1
.- Parameters:
function
-iMin
-iMax
-- Returns:
-
intProduct
public static IExpr intProduct(Function<IInteger,IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code> and evaluate the
S.Product
- Parameters:
function
- the function which should be applied on each iterator valuefrom
- from this position (included)to
- to this position (included)step
-- Returns:
-
intSum
public static IExpr intSum(IntFunction<IExpr> function, int iMin, int iMax)
CalculateSum(function(k), {k, iMin, iMax})
- Parameters:
function
-iMin
- from this position (included)iMax
- to this position (included)- Returns:
-
intSum
public static IExpr intSum(Function<IInteger,IExpr> function, int from, int to, int step)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code> and evaluate the
S.Sum
- Parameters:
function
- the function which should be applied on each iterator valuefrom
- from this position (included)to
- to this position (included)step
-- Returns:
-
intSum
public static IExpr intSum(Function<IInteger,IExpr> function, int from, int to, int step, boolean expand)
Iterate over an integer rangefrom <= i <= to
with the stepstep/code> and evaluate the
S.Sum
-
sum
public static IExpr sum(Function<IInteger,IExpr> function, int iMin, int iMax, int iStep)
Evaluate the sum fromiMin
toiMax
and stepiStep
.- Parameters:
function
-iMin
- from this position (included)iMax
- to this position (included)iStep
-- Returns:
-
sum
public static IExpr sum(Function<IInteger,IExpr> function, int iMin, int iMax, int iStep, boolean expand)
Evaluate the sum fromiMin
toiMax
and stepiStep
.
-
SurfaceGraphics
public static IASTAppendable SurfaceGraphics()
-
Table
public static IAST Table(IExpr expr, IExpr iterationSpecification)
See Table- Parameters:
expr
- expression which should be iteratediterationSpecification
- a standard iteration specification- Returns:
Table(expr, iterationSpecification)
AST
-
Table
public static IAST Table(IExpr expr, IExpr iterationSpecification1, IExpr iterationSpecification2)
-
TagSet
public static IASTMutable TagSet(IExpr a0, IExpr a1, IExpr a2)
-
TagSetDelayed
public static IASTMutable TagSetDelayed(IExpr a0, IExpr a1, IExpr a2)
-
TakeLargest
public static IASTMutable TakeLargest(IExpr a0, IExpr a1)
-
TakeLargestBy
public static IASTMutable TakeLargestBy(IExpr a0, IExpr a1, IExpr a2)
-
TakeSmallest
public static IASTMutable TakeSmallest(IExpr a0, IExpr a1)
-
TakeSmallestBy
public static IASTMutable TakeSmallestBy(IExpr a0, IExpr a1, IExpr a2)
-
ternaryAST3
public static final IASTMutable ternaryAST3(IExpr head, IExpr arg1, IExpr arg2, IExpr arg3)
Create a functionhead(arg1, arg2, arg3)
with 3 argument as anAST3
mutable object without evaluation.- Parameters:
head
-arg1
-arg2
-arg3
-- Returns:
-
TimeConstrained
public static IAST TimeConstrained(IExpr a0, IExpr a1)
See TimeConstrained
-
TimeConstrained
public static IAST TimeConstrained(IExpr a0, IExpr a1, IExpr a2)
See TimeConstrained
-
Times
public static IASTAppendable Times()
See: Times- Returns:
-
TimesAlloc
public static IASTAppendable TimesAlloc(int initialCapacity)
Create a Times() function with allocated space for size elements. See: Times- Parameters:
initialCapacity
- the initialCapacity of this AST- Returns:
-
Times
public static IASTAppendable Times(IExpr x)
See: Times
-
Times
public static IASTMutable Times(IExpr x, IExpr y)
-
timesDistribute
public static IExpr timesDistribute(@Nonnull IExpr x, @Nonnull IExpr y, EvalEngine engine)
-
ToExpression
public static IAST ToExpression(IExpr a0)
See ToExpression
-
toIntDefault
public static int toIntDefault(double value)
Converts this number to anint
value; this method returnsInteger.MIN_VALUE
, if the value of this integer isn't in the rangejava.lang.Integer.MIN_VALUE
+1 tojava.lang.Integer.MAX_VALUE
-1 or the expression is not convertible to theint
range.- Returns:
- the numeric value represented by this expression after conversion to type
int
orInteger.MIN_VALUE
if this expression cannot be converted.
-
toIntDefault
public static int toIntDefault(double value, int defaultValue)
Converts this number to anint
value; this method returnsdefaultValue
, if the value of this integer isn't in the rangejava.lang.Integer.MIN_VALUE
+1 tojava.lang.Integer.MAX_VALUE
-1 or the expression is not convertible to theint
range.- Parameters:
value
-defaultValue
- the default value, if this integer is not in theint
range- Returns:
- the numeric value represented by this integer after conversion to type
int
-
TrigExpand
public static IAST TrigExpand(IExpr expr)
See TrigExpand
-
TrigReduce
public static IAST TrigReduce(IExpr expr)
See TrigReduce
-
unary
public static final IASTAppendable unary(IExpr head, IExpr arg)
Create a functionhead(arg)
with 1 argument without evaluation.- Parameters:
head
-arg
-- Returns:
-
unaryAST1
public static final IASTMutable unaryAST1(IExpr head, IExpr arg)
Create a functionhead(arg)
with 1 argument as anAST1
mutable object without evaluation.- Parameters:
head
-arg
-- Returns:
-
Underflow
public static IAST Underflow()
-
UndirectedEdge
public static IAST UndirectedEdge(IExpr a, IExpr b)
UndirectedEdge
is an undirected edge between the verticesa
andb
in a `graph` object.See: UndirectedEdge
- Parameters:
a
-b
-- Returns:
-
Unequal
public static IAST Unequal(IExpr lhs, IExpr rhs)
YieldsS.False
iflhs
andrhs
are known to be equal, orS.True
iflhs
andrhs
are known to be unequal.See: Unequal
- Parameters:
lhs
-rhs
-- Returns:
-
UnitConvert
public static IAST UnitConvert(IExpr quantity)
Convert thequantity
to the base unit.See: UnitConvert
- Parameters:
quantity
-- Returns:
-
UnitConvert
public static IAST UnitConvert(IExpr quantity, IExpr unit)
- Parameters:
quantity
-unit
-- Returns:
-
With
public static IAST With(IExpr listOfLocalVariables, IExpr expr)
- Parameters:
listOfLocalVariables
-expr
-- Returns:
-
ZeroSymmetric
public static IAST ZeroSymmetric(IExpr a0)
Symmetry of a zero tensor.- Parameters:
a0
-- Returns:
-
ZZ
public static IInteger ZZ(BigInteger integerValue)
Create a large integer number.- Parameters:
integerValue
-- Returns:
-
ZZ
public static IInteger ZZ(int integerValue)
Create an integer number by using the internal small integer number cache. The returned object references might be the same.- Parameters:
integerValue
-- Returns:
-
ZZUniqueReference
public static IInteger ZZUniqueReference(int integerValue)
Create a new integer number without using the internal small integer number cache. The returned object references will always be newly created.- Parameters:
integerValue
-- Returns:
-
ZZ
public static IInteger ZZ(long integerValue)
Create an integer number.- Parameters:
integerValue
-- Returns:
-
ZZ
public static IInteger ZZ(String integerString, int radix)
Create a large integer number.- Parameters:
integerString
- the integer number represented as a Stringradix
- the radix to be used while parsing- Returns:
- Object
-
operatorForm1Append
public static IAST operatorForm1Append(IAST ast1)
The operator formop(f)[expr]
is transformed toop(expr, f)
. The operator formop(f, g)[expr]
is transformed toop(expr, f, g)
- Parameters:
ast1
- an IAST with conditionast1Arg.head().isAST1() && ast1Arg.isAST1()
- Returns:
-
operatorFormAppend2
public static IAST operatorFormAppend2(IAST astArg)
The binary operator formop(f, g)[expr]
is transformed toop(expr, f, g)
- Parameters:
astArg
- an IAST with conditionastArg.head().isAST2() && astArg.isAST1()
- Returns:
-
operatorForm2Prepend
public static IAST operatorForm2Prepend(IAST ast1, int[] expected, EvalEngine engine)
The operator formop(f)[expr]
is transformed toop(f, expr)
. The operator formop(f)[expr1, expr2]
is transformed toop(f, expr1, expr2)
.- Parameters:
ast1
- anIAST
with conditionast1Arg.head().isAST1() && ast1Arg.isAST1()
- Returns:
-
matrix
public static IAST matrix(BiIntFunction<? extends IExpr> biFunction, int n, int m)
Generate an x m
matrix. The indices start in Java convention with0
.- Parameters:
biFunction
-n
- the number of rows of the matrix.m
- the number of elements in one row- Returns:
-
vector
public static IAST vector(IntFunction<? extends IExpr> iFunction, int n)
Generate a vector withn
elements.- Parameters:
iFunction
-n
- the number of elements of the vector.- Returns:
-
fromString
public static IExpr fromString(String string)
Parses a given string to an instance ofIExpr
Examples:
"7/9" -> RationalScalar.of(7, 9) "3.14" -> DoubleScalar.of(3.14) "(3+2)*I/(-1+4)+8-I" -> ComplexScalar.of(8, 2/3) == "8+2/3*I" "9.81[m*s^-2]" -> Quantity.of(9.81, "m*s^-2")
If the parsing logic encounters an inconsistency, the return type is aIStringX
that holds the input string.Scalar types that are not supported include
GaussScalar
.- Parameters:
string
-- Returns:
- scalar
-
show
public static String show(IExpr expr)
Show the result in an HTML page with the help of the JavaDesktop.getDesktop().open()
method. On some platforms the Desktop API may not be supported; use theisDesktopSupported()
method todetermine if the current desktop is supported.- Parameters:
expr
-- Returns:
- Throws:
IOException
-
openHTMLOnDesktop
public static String openHTMLOnDesktop(String html) throws IOException
- Throws:
IOException
-
flattenSequence
public static IAST flattenSequence(IAST list)
Iterate over the arguments oflist
and flatten the arguments ofSequence(...)
expressions. (i.e.{Sequence(a,b,...)}
is rewritten as{a,b,...}
). If some of the elements is the symbolNothing
it's automatically removed from the arguments.- Parameters:
list
- an AST which may containSequence(...)
expressions orNothing
symbols.- Returns:
F.NIL
if no sequence is flattened
-
-