JuliaWSExpression¶
jwsexpr.spad line 1 [edit on github]
Julia Wolfram Symbolic expressions using Wolfram Symbolic Transport Protocol.
- 0: %
from AbelianMonoid
- 1: %
from MagmaWithUnit
- #: % -> JuliaWSInteger
from JuliaWSAggregate %
- *: (%, %) -> %
from Magma
- *: (%, Fraction Integer) -> %
from RightModule Fraction Integer
- *: (Fraction Integer, %) -> %
from LeftModule Fraction Integer
- *: (Integer, %) -> %
from AbelianGroup
- *: (NonNegativeInteger, %) -> %
from AbelianMonoid
- *: (PositiveInteger, %) -> %
from AbelianSemiGroup
- +: (%, %) -> %
from AbelianSemiGroup
- -: % -> %
from AbelianGroup
- -: (%, %) -> %
from AbelianGroup
- /: (%, %) -> %
from Group
- /: (SparseMultivariatePolynomial(%, Kernel %), SparseMultivariatePolynomial(%, Kernel %)) -> %
from FunctionSpace2(%, Kernel %)
- <=: (%, %) -> Boolean
from PartialOrder
- <: (%, %) -> Boolean
from PartialOrder
- >=: (%, %) -> Boolean
from PartialOrder
- >: (%, %) -> Boolean
from PartialOrder
- ^: (%, JuliaWSRational) -> %
^ is the exponentiation by a rational.
- ^: (%, NonNegativeInteger) -> %
from MagmaWithUnit
- ^: (%, PositiveInteger) -> %
from Magma
- abs: % -> %
from ComplexCategory %
- acos: % -> %
- acosh: % -> %
- acot: % -> %
- acoth: % -> %
- acsc: % -> %
- acsch: % -> %
- airyAi: % -> %
- airyAiPrime: % -> %
- airyBi: % -> %
- airyBiPrime: % -> %
- algtower: % -> List Kernel %
from FunctionSpace2(%, Kernel %)
- algtower: List % -> List Kernel %
from FunctionSpace2(%, Kernel %)
- angerJ: (%, %) -> %
- annihilate?: (%, %) -> Boolean
from Rng
- antiCommutator: (%, %) -> %
- apart: % -> %
apart(expr)
converts a rational expression as a sum of terms, reducing denominator(s
).
- apart: (%, %) -> %
apart(expr, vars)
converts a rational expression as a sum of terms as one arg apart do but only for vars (the others are considered as constants).
- append: (%, %) -> %
from JuliaWSAggregate %
- applyQuote: (Symbol, %) -> %
from FunctionSpace2(%, Kernel %)
- applyQuote: (Symbol, %, %) -> %
from FunctionSpace2(%, Kernel %)
- applyQuote: (Symbol, %, %, %) -> %
from FunctionSpace2(%, Kernel %)
- applyQuote: (Symbol, %, %, %, %) -> %
from FunctionSpace2(%, Kernel %)
- applyQuote: (Symbol, List %) -> %
from FunctionSpace2(%, Kernel %)
- argument: % -> %
from ComplexCategory %
- asec: % -> %
- asech: % -> %
- asin: % -> %
- asinh: % -> %
- associates?: (%, %) -> Boolean
from EntireRing
- associator: (%, %, %) -> %
from NonAssociativeRng
- atan: % -> %
- atan: (%, %) -> %
atan(x,y)
computes the arc tangent ofy/x
.
- atanh: % -> %
- barnesG: % -> %
barnesG(z)
computes the BarnesG
-function ofz
.
- basis: () -> Vector %
from FramedModule %
- belong?: BasicOperator -> Boolean
from ExpressionSpace2 Kernel %
- besselI: (%, %) -> %
- besselJ: (%, %) -> %
- besselK: (%, %) -> %
- besselY: (%, %) -> %
- BetaRegularized: (%, %, %) -> %
BetaRegularized(x,a,b)
computes the regularized incomplete beta function.
- binomial: (%, %) -> %
- box: % -> %
from ExpressionSpace2 Kernel %
- cancel: % -> %
cancel(expr)
cancels common factors in numerators and denominators of the rational expressionexpr
.
- cancel: (%, %) -> %
cancel(expr, opt)
cancels common factors in numerators and denominators of the rational expressionexpr
with options opt, for example an Extension rule.
- catalan: () -> %
catalan()
returns Catalan's
contant.
- ceiling: % -> %
ceiling(x)
returns the smallest integer greater than or equal tox
.
- characteristic: () -> NonNegativeInteger
from NonAssociativeRing
- characteristicPolynomial: % -> SparseUnivariatePolynomial %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- charlierC: (%, %, %) -> %
- chebyshevT: (%, %) -> %
chebyshevT(n, expr)
returns the chebyshev polynomial of the first kind or evaluates it atx
ifx
is a number.
- chebyshevU: (%, %) -> %
chebyshevU(n, expr)
returns chebyshev polynomial of the second kind or evaluates it atx
ifx
is a number.
- Chi: % -> %
- Ci: % -> %
- coefficient: (%, %) -> %
coefficient(p,expr)
returns the coefficient ofexpr
inp
. example{x:= jWSExpr x} example{coefficient((x - y)^4, x * y^3)}
- coefficient: (%, %, %) -> %
coefficient(p, expr, n)
returns the coefficient of expr^n inp
.
- coefficientList: (%, %) -> %
coefficientList(p,expr)
returns the list of coefficients ofexpr
inp
.
- coefficientRules: % -> %
coefficientRules(p)
returns the coefficients and exponents ofp
asWS
rules.
- coefficientRules: (%, %) -> %
coefficientRules(p,vars)
returns the coefficients and exponents ofp
with respect to var(s
) asWS
rules.
- coerce: % -> %
from CoercibleFrom %
- coerce: % -> JuliaWSExpression
from JuliaWSAggregate %
- coerce: % -> OutputForm
from CoercibleTo OutputForm
- coerce: Float -> %
coerce(f)
coerces the floating point numberf
to a JuliaWSExpression. Convenience function.- coerce: Fraction % -> %
from FunctionSpace2(%, Kernel %)
- coerce: Fraction Integer -> %
coerce(q)
coerces the rationalq
to a JuliaWSExpression. Convenience function.- coerce: Fraction Polynomial % -> %
from CoercibleFrom Fraction Polynomial %
- coerce: Fraction Polynomial Fraction % -> %
from FunctionSpace2(%, Kernel %)
- coerce: Integer -> %
coerce(z)
coerces the integerz
to a JuliaWSExpression. Convenience function.- coerce: Kernel % -> %
from CoercibleFrom Kernel %
- coerce: List % -> %
coerce(list)
coerceslist
of JuliaWSExpression.- coerce: Polynomial % -> %
from CoercibleFrom Polynomial %
- coerce: Polynomial Fraction % -> %
from FunctionSpace2(%, Kernel %)
- coerce: SparseMultivariatePolynomial(%, Kernel %) -> %
from FunctionSpace2(%, Kernel %)
- coerce: String -> %
coerce(str)
coerces the stringstr
to a JuliaWSExpression evaluatingstr
as a Wolfram Symbolic Language Expression. For example: example{expr := “Sqrt[x]”::JWSEXPR;jlEval(expr,”x=2.0”)}
- coerce: Symbol -> %
coerce(sym)
coercessym
to a JuliaWSExpression.
- collect: (%, %) -> %
collect(expr, var)
collects same power terms with respect to variable var.
- collect: (%, JuliaWSList %) -> %
collect(expr, vars)
collects same power terms with respect to variables in vars.
- commutator: (%, %) -> %
from NonAssociativeRng
- complex: (%, %) -> %
from ComplexCategory %
- complexExpand: % -> %
complexExpand(expr)
expandsexpr
assuming variables are real.
- complexExpand: (%, %) -> %
complexExpand(expr, cvars)
expandsexpr
assuming all but cvars variables are real.
- conditionP: Matrix % -> Union(Vector %, failed) if % has CharacteristicNonZero and % has PolynomialFactorizationExplicit or % has FiniteFieldCategory
- conjugate: % -> %
from ComplexCategory %
- convert: % -> SparseUnivariatePolynomial %
- convert: % -> String
from ConvertibleTo String
- convert: % -> Vector %
from FramedModule %
- convert: Factored % -> %
from FunctionSpace2(%, Kernel %)
- convert: SparseUnivariatePolynomial % -> %
from MonogenicAlgebra(%, SparseUnivariatePolynomial %)
- convert: Vector % -> %
from FramedModule %
- coordinates: % -> Vector %
from FramedModule %
- coordinates: (%, Vector %) -> Vector %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- coordinates: (Vector %, Vector %) -> Matrix %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- coordinates: Vector % -> Matrix %
from FramedModule %
- cos: % -> %
- cosh: % -> %
- cot: % -> %
- coth: % -> %
- coulombF: (%, %, %) -> %
coulombF(l,eta,ro)
is the regular Coulomb wave function.
- coulombG: (%, %, %) -> %
coulombG(l,eta,ro)
is the irregular Coulomb wave function.
- coulombH1: (%, %, %) -> %
coulombH1(l,eta,ro)
is the incoming irregular Coulomb wave functionH^
(+).
- coulombH2: (%, %, %) -> %
coulombH2(l,eta,ro)
is the incoming irregular Coulomb wave functionH^
(-).
- csc: % -> %
- csch: % -> %
- D: (%, % -> %) -> %
from DifferentialExtension %
- D: (%, % -> %, NonNegativeInteger) -> %
from DifferentialExtension %
- D: (%, %) -> %
from PartialDifferentialRing %
- D: (%, %, NonNegativeInteger) -> %
from PartialDifferentialRing %
- D: (%, List %) -> %
from PartialDifferentialRing %
- D: (%, List %, List NonNegativeInteger) -> %
from PartialDifferentialRing %
- D: (%, List Symbol) -> %
- D: (%, List Symbol, List NonNegativeInteger) -> %
- D: (%, Symbol) -> %
- D: (%, Symbol, NonNegativeInteger) -> %
- dawson: % -> %
dawson(x)
computes the Dawson integral ofx
.
- decompose: (%, %) -> JuliaWSList %
decompose(poly, x)
is a polynomial decomposition function, here, related tox
.
- dedekindEta: % -> %
dedekindEta(tau)
computes the Dedekind modular elliptic eta.
- definingPolynomial: % -> %
from ExpressionSpace2 Kernel %
- definingPolynomial: () -> SparseUnivariatePolynomial %
from MonogenicAlgebra(%, SparseUnivariatePolynomial %)
- degree: () -> %
degree()
returns conversion factor from degrees to radians,π/180
.
- delete: (%, JuliaWSList JuliaWSInteger) -> %
from JuliaWSAggregate %
- denom: % -> SparseMultivariatePolynomial(%, Kernel %)
from FunctionSpace2(%, Kernel %)
- denominator: % -> %
denominator(expr)
returns the denominator ofexpr
.
- derivationCoordinates: (Vector %, % -> %) -> Matrix %
from MonogenicAlgebra(%, SparseUnivariatePolynomial %)
- derivative: (BasicOperator, %) -> %
derivative(func,n)
returns the derivative of ordern
offunc
. example{fprime:=derivative(operator(‘f),1)}
- derivative: (BasicOperator, %, %) -> %
derivative(func, n, var)
returns the derivative of ordern
offunc
applied to var. example{x := jWSExpr x} example{fprimex:=derivative(operator(‘f),1,x)}
- differentiate: (%, % -> %) -> %
from DifferentialExtension %
- differentiate: (%, % -> %, NonNegativeInteger) -> %
from DifferentialExtension %
- differentiate: (%, %) -> %
from PartialDifferentialRing %
- differentiate: (%, %, NonNegativeInteger) -> %
from PartialDifferentialRing %
- differentiate: (%, List %) -> %
from PartialDifferentialRing %
- differentiate: (%, List %, List NonNegativeInteger) -> %
from PartialDifferentialRing %
- differentiate: (%, List Symbol) -> %
- differentiate: (%, List Symbol, List NonNegativeInteger) -> %
- differentiate: (%, Symbol) -> %
- differentiate: (%, Symbol, NonNegativeInteger) -> %
- digamma: % -> %
- digamma: (%, %) -> %
digamma(n,z)
then
-th derivative of the digamma function
- dilog: % -> %
- dimensions: % -> JuliaWSList JuliaWSInteger
from JuliaWSAggregate %
- diracDelta: % -> %
- dirichletEta: % -> %
dirichletEta(z)
computes the Dirichlet eta.
- dirichletL: (%, %, %) -> %
dirichletL(k,j,s)
returns DirichletL
-function ofs
, modulusk
, indexj
.
- discriminant: (%, %) -> %
discriminant(p, x)
returns the discriminant ofp
with respect tox
.- discriminant: () -> %
from FramedAlgebra(%, SparseUnivariatePolynomial %)
- discriminant: Vector % -> %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- distribute: % -> %
distribute(expr)
distributesexpr
over addition. For illustration: example{distribute(jWSExpr “(x + y) * (a + b + c)”)}
- distribute: (%, %) -> %
distribute(f,g)
distributesf
overg
.
- divide: (%, %) -> Record(quotient: %, remainder: %)
from EuclideanDomain
- dSolve: (%, %, %) -> %
dSolve(expr, funcs, vars)
solves the (list of) differential equation(s
)expr
for the function(s
)funcs
with independant variable(s
) vars. example{x:=jWSExpr x;} example{fx:=derivative(operator(‘f),0,x)} example{fprimex:=derivative(operator(‘f),1,x)} example{dSolve(jWSEqual(fprimex + fx , a *sin(x)),fx,x)}
- dSolve: (Equation %, %, %) -> %
dSolve(eq, func,var)
solves the differential equationeq
for the function(s
) funcs with independant variable(s
) vars. example{x:=jWSExpr x;} example{fx:=derivative(operator(‘f),0,x)} example{fprimex:=derivative(operator(‘f),1,x)} example{dSolve(fprimex + fx = a * sin(x)/cos(x),fx,x)}
- dSolveValue: (%, %, %) -> %
dSolveValue(expr,funcs, vars)
returns the value determined by the differential equation(s
) inexpr
for the function(s
)funcs
with independant variable(s
) vars. example{x:=jWSExpr x;} example{f:=derivative(operator(‘f),0)} example{f0:=derivative(operator(‘f),0,0)} example{fx:=derivative(operator(‘f),0,x)} example{fprimex:=derivative(operator(‘f),1,x)} example{dSolveValue(jWSExpr([jWSEqual(fprimex + fx , a *sin(x)/cos(x)), jWSEqual(f0,0)]),f,x)}
- dSolveValue: (Equation %, %, %) -> %
dSolveValue(eq, func,var)
returns the value determined by the differential equationeq
for the functionfunc
with independant variablevar
.
- Ei: % -> %
- EiEn: (%, %) -> %
EiEn(n,z)
returns the exponential integral En(z
).
- ellipticE: % -> %
ellipticE(x)
computes the complete elliptic integral of the second kind.
- ellipticE: (%, %) -> %
ellipticE(phi,m)
computes the elliptic integral of the second kind.
- ellipticF: (%, %) -> %
ellipticF(phi,m)
computes the elliptic integral of the first kind.
- ellipticK: % -> %
ellipticK(m)
computes the complete elliptic integral of the first kind.
- ellipticPi: (%, %) -> %
ellipticPi(n,m)
computes the complete elliptic integral of the third kind.
- ellipticPi: (%, %, %) -> %
ellipticPi(n,phi,m)
computes the elliptic integral of the third kind.
- ellipticTheta: (%, %, %) -> %
ellipticTheta(a, u, q)
computes the theta function, a ranges from 1 to 4.
- ellipticThetaPrime: (%, %, %) -> %
ellipticThetaPrime(a, u, q)
computes the derivative of the theta function, a ranges from 1 to 4.
- elt: (%, Integer) -> %
from JuliaWSAggregate %
- elt: (BasicOperator, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %, %, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %, %, %, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %, %, %, %, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %, %, %, %, %, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, %, %, %, %, %, %, %, %, %) -> %
from ExpressionSpace2 Kernel %
- elt: (BasicOperator, List %) -> %
from ExpressionSpace2 Kernel %
- erf: % -> %
- erf: (%, %) -> %
erf(x,x1)
computes the generalized error function.
- erfc: % -> %
erfc(x)
computes the complementary error function.
- erfi: % -> %
- euclideanSize: % -> NonNegativeInteger
from EuclideanDomain
- eulerE: % -> %
eulerE(n)
returns the Euler number En.
- eulerE: (%, %) -> %
eulerE(n,z)
return the EulerE
polynomial of degreen
.
- eulerGamma: () -> %
eulerGamma()
returns the Euler's
constant gamma (γ
).
- eulerPhi: % -> %
eulerPhi(n)
is the totient function i.e. the number of integers that are relatively prime ton
in the range [1,n
].
- eval: (%, %, %) -> %
from InnerEvalable(%, %)
- eval: (%, BasicOperator, % -> %) -> %
from ExpressionSpace2 Kernel %
- eval: (%, BasicOperator, List % -> %) -> %
from ExpressionSpace2 Kernel %
- eval: (%, Equation %) -> %
from Evalable %
- eval: (%, Kernel %, %) -> %
from InnerEvalable(Kernel %, %)
- eval: (%, List %, List %) -> %
from InnerEvalable(%, %)
- eval: (%, List BasicOperator, List(% -> %)) -> %
from ExpressionSpace2 Kernel %
- eval: (%, List BasicOperator, List(List % -> %)) -> %
from ExpressionSpace2 Kernel %
- eval: (%, List Equation %) -> %
from Evalable %
- eval: (%, List Kernel %, List %) -> %
from InnerEvalable(Kernel %, %)
- eval: (%, List Symbol, List NonNegativeInteger, List(% -> %)) -> %
from FunctionSpace2(%, Kernel %)
- eval: (%, List Symbol, List NonNegativeInteger, List(List % -> %)) -> %
from FunctionSpace2(%, Kernel %)
- eval: (%, List Symbol, List(% -> %)) -> %
from ExpressionSpace2 Kernel %
- eval: (%, List Symbol, List(List % -> %)) -> %
from ExpressionSpace2 Kernel %
- eval: (%, Symbol, % -> %) -> %
from ExpressionSpace2 Kernel %
- eval: (%, Symbol, List % -> %) -> %
from ExpressionSpace2 Kernel %
- eval: (%, Symbol, NonNegativeInteger, % -> %) -> %
from FunctionSpace2(%, Kernel %)
- eval: (%, Symbol, NonNegativeInteger, List % -> %) -> %
from FunctionSpace2(%, Kernel %)
- exp: % -> %
- exp: () -> %
exp()
returnsℯ
(%e
or exp(1)).
- expand: % -> %
expand(expr)
puts out products and positive powers of integers of the expressionexpr
.
- expand: (%, %) -> %
expand(expr, opt)
this the expand version with excluded pattern-s
or any other options avaiable (for example “Modulus->p"
).
- expandDenominator: % -> %
expandDenominator(expr)
expands denominators of rational expressionexpr
.
- expandNumerator: % -> %
expandNumerator(expr)
expands numerators of rational expressionexpr
.
- exponent: (%, %) -> %
exponent(p,expr)
returns the maximaum exponent ofp
forexpr
. example{x:= jWSExpr x;y := jWSExpr y} example{p:=(x^2-2)^3*(y*x^3+x^11*y^7)*(y^5+x*y^2+x^11+y)} example{exponent(%,(x^2-2))}
- exponent: (%, %, %) -> %
exponent(p, expr, map)
applies map to the exponents related toexpr
and returns it. By default map = “Max”. example{x:= jWSExpr x;y := jWSExpr y} example{p:=expand((x^2-2)^3*(y*x^3+x^11*y^7)*(y^5+x*y^2+x^11+y))} example{exponent(p,x,”Min”)}
- expressIdealMember: (List %, %) -> Union(List %, failed)
from PrincipalIdealDomain
- expToTrig: % -> %
expToTrig(expr)
returnsexpr
with exponentials converted to (hyperbolic) trigonometric functions.
- exquo: (%, %) -> Union(%, failed)
from EntireRing
- extendedEuclidean: (%, %) -> Record(coef1: %, coef2: %, generator: %)
from EuclideanDomain
- extendedEuclidean: (%, %, %) -> Union(Record(coef1: %, coef2: %), failed)
from EuclideanDomain
- extendedExpand: % -> %
extendedExpand(expr)
puts out all products and positive powers of integers.
- extendedSimplify: % -> %
extendedSimplify(expr)
extended version of simplify. This is the full version of simplify.
- extendedSimplify: (%, %) -> %
extendedSimplify(expr, assumptions)
extended version of simplify with respect to assumptions or ExcludedForms. This is the full version.
- extract: (%, JuliaWSExpression) -> %
from JuliaWSAggregate %
- extract: (%, NonNegativeInteger) -> %
extract(expr,i)
returns thei
-th element ofexpr
seen as a list.
- factor: (%, %) -> %
factor(expr, opt)
factors the expression or polynomialexpr
. For example: example{x := jWSExpr x;} example{factor(1 + x^2, “GaussianIntegers -> True”)}
- factorial: % -> %
- factorials: % -> %
- factorials: (%, Symbol) -> %
- factorList: % -> JuliaWSList JuliaWSList %
factorList(expr)
factor the expression or polynomialexpr
, but returns result as a list of pair (factor, exponent).
- factorPolynomial: SparseUnivariatePolynomial % -> Factored SparseUnivariatePolynomial % if % has PolynomialFactorizationExplicit
- factorSquareFree: % -> %
factorSquareFree(expr)
factors the expression or polynomialexpr
in square free factors.
- factorSquareFreeList: % -> JuliaWSList JuliaWSList %
factorSquareFreeList(expr)
factors the expression or polynomialexpr
in square free factors but returns result as a list of pair (factor, exponent).
- factorSquareFreePolynomial: SparseUnivariatePolynomial % -> Factored SparseUnivariatePolynomial % if % has PolynomialFactorizationExplicit
- factorTerms: % -> %
factorTerms(p)
factors out numerical factor of the expression or polynomial expr.
- factorTerms: (%, %) -> %
factorTerms(p, var)
factors out numerical factor of the expression or polynomial expr without those related to var.
- factorTerms: (%, JuliaWSList %) -> %
factorTerms(p, vars)
factors the expression or polynomial expr by putting out numerical factors without those related to var(s
).
- factorTermsList: % -> JuliaWSList %
factorTermsList(expr)
is the counterpart of factorTerms but here returned as a list of pair (numerical factor, polynomial factor).
- factorTermsList: (%, %) -> JuliaWSList %
factorTermsList(expr, vars)
is the counterpart of factorTerms but here returned as a list of pair (numerical factor, polynomial factor). The numerical factors related to var(s
) are not factored.
- fibonacci: (%, %) -> %
fibonacci(n, x)
returns the Fibonacci polynomial or evaluates it atx
ifx
is a number.
- findInstance: (%, %) -> JuliaWSList JuliaWSList %
findInstance(expr,lvars)
tries to find an instance the (in)equation inexpr
.
- findInstance: (%, %, %) -> JuliaWSList JuliaWSList %
findInstance(expr,lvars,dom)
tries to find an instance to the equation inexpr
.
- findInstance: (%, %, %, %) -> JuliaWSList JuliaWSList %
findInstance(expr,lvars,dom, n)
tries to findn
instance(s
) to the (in)equation inexpr
.
- findInstance: (Equation %, %) -> JuliaWSList JuliaWSList %
findInstance(expr,lvars)
tries to find an instance the equation inexpr
.
- findInstance: (Equation %, %, %) -> JuliaWSList JuliaWSList %
findInstance(expr,lvars,dom)
tries to find an instance the equation inexpr
.
- findInstance: (Equation %, %, %, %) -> JuliaWSList JuliaWSList %
findInstance(expr,lvars,dom,n)
tries to findn
instance(s
) to the equation inexpr
.
- findRoot: (%, %) -> %
findRoot(exp,start)
try to find the root of expr starting atstart
. example{findRoot(sin(x) + cos(x), “{x, 0}”)}
- first: % -> %
from JuliaWSAggregate %
- floor: % -> %
floor(x)
returns the greatest integer less than or equal tox
- fractionPart: % -> %
- freeOf?: (%, %) -> Boolean
from ExpressionSpace2 Kernel %
- freeOf?: (%, Symbol) -> Boolean
from ExpressionSpace2 Kernel %
- fresnelC: % -> %
- fresnelS: % -> %
- fromCoefficientRules: (%, %) -> %
fromCoefficientRules(list, vars)
constructs the polynomial from thelist
of coefficients and exponents rules. example{x:= jWSExpr x;y := jWSExpr y} example{coefficientRules((x + y)^2+x^11,jWSExpr [x,y])} example{fromCoefficientRules(%, jWSExpr [x,y])}
- functionExpand: % -> %
functionExpand(expr)
tries to expand functions inexpr
to more elementary functions. For example: example{functionExpand sphericalBesselJ(3,8)}
- functionExpand: (%, %) -> %
functionExpand(expr,assumptions)
tries to expand functions inexpr
to more elementary functions assuming thatassumptions
are satisfied.
- Gamma: (%, %, %) -> %
Gamma(a,z1,z2)
computes the generalized incomplete gamma function.
- GammaRegularized: (%, %) -> %
GammaRegularized(a,x)
computes the regularized incomplete gamma function.
- gcdPolynomial: (SparseUnivariatePolynomial %, SparseUnivariatePolynomial %) -> SparseUnivariatePolynomial %
from GcdDomain
- gegenbauerC: (%, %) -> %
gegenbauerC(n,x)
returns the renormalized form of the Gegenbauer polynomial or evaluates it atx
ifx
is a number.
- gegenbauerC: (%, %, %) -> %
gegenbauerC(n,lambda,x)
returns the Gegenbauer polynomial or evaluates it atx
ifx
is a number.
- generator: () -> %
from MonogenicAlgebra(%, SparseUnivariatePolynomial %)
- goldenRatio: () -> %
goldenRatio()
returns the golden ratio.
- groebnerBasis: (%, %) -> JuliaWSList %
groebnerBasis(lpoly, lvar)
computes a Groebner basis from the list of polynomialslpoly
relative to the list of vars lvars.
- groebnerBasis: (%, %, %) -> JuliaWSList %
groebnerBasis(lpoly, lvar, opt)
computes a Groebner basis from the list of polynomialslpoly
relative to the list of variables in lvars without variables in opt. Opt can also give the modulus to compute it: “Modulus->
p"
.
- ground?: % -> Boolean
from FunctionSpace2(%, Kernel %)
- ground: % -> %
from FunctionSpace2(%, Kernel %)
- gudermannian: % -> %
gudermannian(z)
computes the gudermannian ofz
.
- hahn_p: (%, %, %, %, %) -> %
- hahnQ: (%, %, %, %, %) -> %
- hahnR: (%, %, %, %, %) -> %
- hahnS: (%, %, %, %, %) -> %
- hankelH1: (%, %) -> %
- hankelH2: (%, %) -> %
- hash: % -> SingleInteger if % has Hashable
from Hashable
- hashUpdate!: (HashState, %) -> HashState if % has Hashable
from Hashable
- haversine: % -> %
haversine(z)
computes the haversine ofz
.
- height: % -> NonNegativeInteger
from ExpressionSpace2 Kernel %
- hermiteH: (%, %) -> %
hermiteH(n, x)
returns the Hermite polynomial or evaluates it atx
ifx
is a number.
- hornerForm: (%, %) -> %
hornerForm(expr, x)
returns the Horner form ofexpr
(minimizing multiplications).
- hurwitzLerchPhi: (%, %, %) -> %
hurwitzLerchPhi(z,s,a)
computes the Hurwitz–Lerch transcendent phi function.
- hurwitzZeta: (%, %) -> %
hurwitzZeta(s,a)
computes the Hurwitz zeta.
- hyperFactorial: % -> %
hyperFactorial(n)
computes the hyperfactorial ofn
.
- hypergeometric0F1: (%, %) -> %
hypergeometric0F1(a,z)
is the hypergeometric 0F1.
- hypergeometric0F1Regularized: (%, %) -> %
hypergeometric0F1Regularized(a,z)
is the regularized hypergeometric 0F1.
- hypergeometric1F1: (%, %, %) -> %
hypergeometric1F1(a,b,z)
is the Kummer confluent hypergeometric function 1F1.
- hypergeometric1F1Regularized: (%, %, %) -> %
hypergeometric1F1Regularized(a,b,z)
is the regularized confluent hypergeometric function 1F1.
- hypergeometricU: (%, %, %) -> %
hypergeometricU(a,b,z)
is the confluent hypergeometric functionU
.
- imag: % -> %
from ComplexCategory %
- imaginary: () -> %
from ComplexCategory %
- insert: (%, %, JuliaWSInteger) -> %
from JuliaWSAggregate %
- integral: (%, SegmentBinding %) -> %
- integral: (%, Symbol) -> %
- integrate: (%, %) -> %
integrate(expr, opts|var)
integrateexpr
with respect to opt or var as options. For example: example{x:=jWSExpr x;integrate(1/(x^4-1),x)} example{opt:=jWSList [x,-1,1]} example{integrate(cos(x),opt)}=>
2 sin(1) example{integrate(cos(x),”{x,-1.0,1.0}”)}=>
1.68294
- integrate: (%, %, Segment Integer) -> %
integrate(expr, var, seg)
is the definite integration ofexpr
with respect tovar
using segment seg.
- integrate: (%, Symbol) -> %
integrate(expr, var)
is the indefinite integration ofexpr
with repect to var.
- interpolatingPolynomial: (%, %) -> %
interpolatingPolynomial(lpoly,x)
interpolates the list of polynomialslpoly
with respect tox
.
- intersection: (%, %) -> %
from JuliaWSAggregate %
- inverseBetaRegularized: (%, %, %) -> %
inverseBetaRegularized(s,a,b)
computes the beta inverse.
- inverseErf: % -> %
inverseErf(x)
computes the inverse error function ofx
.
- inverseErfc: % -> %
inverseErfc(x)
computes the inverse complementary error function ofx
.
- inverseGammaRegularized: (%, %) -> %
inverseGammaRegularized(a,s)
computes the gamma inverse.
- inverseGudermannian: % -> %
inverseGudermannian(z)
computes the inverse gudermannian.
- inverseHaversine: % -> %
inverseHaversine(z)
computes the inverse haversine.
- inverseJacobiCn: (%, %) -> %
inverseJacobiCn(nu, m)
computes the inverse JacobiCN elliptic function.
- inverseJacobiSn: (%, %) -> %
inverseJacobiSn(nu, m)
computes the inverse JacobiSN elliptic function.
- irreducible?: % -> Boolean
irreducible?(p)
checks whether or notp
is irreducible.
- irreducible?: (%, %) -> Boolean
irreducible?(p)
checks whether or notp
is irreducible over Gaussian rationals or algebraic extensions.
- is?: (%, BasicOperator) -> Boolean
from ExpressionSpace2 Kernel %
- is?: (%, Symbol) -> Boolean
from ExpressionSpace2 Kernel %
- isExpt: % -> Union(Record(var: Kernel %, exponent: Integer), failed)
from FunctionSpace2(%, Kernel %)
- isExpt: (%, BasicOperator) -> Union(Record(var: Kernel %, exponent: Integer), failed)
from FunctionSpace2(%, Kernel %)
- isExpt: (%, Symbol) -> Union(Record(var: Kernel %, exponent: Integer), failed)
from FunctionSpace2(%, Kernel %)
- isMult: % -> Union(Record(coef: Integer, var: Kernel %), failed)
from FunctionSpace2(%, Kernel %)
- isPlus: % -> Union(List %, failed)
from FunctionSpace2(%, Kernel %)
- isPower: % -> Union(Record(val: %, exponent: Integer), failed)
from FunctionSpace2(%, Kernel %)
- isTimes: % -> Union(List %, failed)
from FunctionSpace2(%, Kernel %)
- jacobiAmplitude: (%, %) -> %
jacobiAmplitude(u,m)
computes the amplitude function am.
- jacobiCn: (%, %) -> %
- jacobiDn: (%, %) -> %
- jacobiP: (%, %, %, %) -> %
jacobiP(n, a, b, x)
returns the Jacobi polynomial or evaluates it atx
ifx
is a number.
- jacobiSn: (%, %) -> %
- jacobiTheta: (%, %) -> %
- jacobiZeta: (%, %) -> %
jacobiZeta(phi,m)
computes the Jacobi Zeta function.
- jlAbout: % -> Void
from JuliaObjectType
- jlApply: (String, %) -> %
from JuliaObjectType
- jlApply: (String, %, %) -> %
from JuliaObjectType
- jlApply: (String, %, %, %) -> %
from JuliaObjectType
- jlApply: (String, %, %, %, %) -> %
from JuliaObjectType
- jlApply: (String, %, %, %, %, %) -> %
from JuliaObjectType
- jlApply: (String, %, %, %, %, %, %) -> %
from JuliaObjectType
- jlEval: % -> %
from JuliaWSObject
- jlEval: (%, String) -> %
jlEval(expr, param)
evaluates expressionexpr
with param as parameter(s
). For example: example{x:=jWSExpr(“x”);jlEval(sqrt(x),”x=2.0”)}
- jlEval: (%, String, String) -> %
jlEval(expr, param11, param2)
evaluates expressionexpr
withparam1
andparam2
as parameters. example{a:=jWSExpr(“a”);b:=jWSExpr(“b”);} example{jlEval(sqrt(a^2+b^2),”a=1.0”,”b=1.0”)}
- jlEval: (%, String, String, String) -> %
jlEval(expr, param11, param2, param3)
evaluates expressionexpr
withparam1
,param2
andparam3
as parameters.
- jlHead: % -> JuliaWSSymbol
from JuliaWSObject
- jlId: % -> String
from JuliaObjectType
- jlNumeric: % -> %
from JuliaWSObject
- jlNumeric: (%, PositiveInteger) -> %
from JuliaWSObject
- jlRef: % -> SExpression
from JuliaObjectType
- jlref: String -> %
from JuliaObjectType
- jlSymbolic: % -> String
from JuliaWSObject
- jlType: % -> String
from JuliaObjectType
- jlWSAccuracy: % -> %
jlWSAccuracy(expr)
get accuracy ofexpr
.
- jlWSPrecision: % -> %
jlWSPrecision get
precision of expr.
- jlWSSetAccuracy: (%, %) -> %
jlWSSetAccuracy(expr, acc)
set accuracy ofexpr
to acc.
- jlWSSetOptions: (%, %) -> %
jlWSSetOptions(type, opts)
sets some internal engine options.
- jlWSSetPrecision: (%, %) -> %
jlWSSetPrecision(expr, prec)
set precision ofexpr
to prec.
- join: (%, %) -> %
from JuliaWSAggregate %
- jWSAggregate: List % -> %
from JuliaWSAggregate %
- jWSEqual: (%, %) -> %
jWSEqual(lhs,rhs)
returns the JuliaWS
equalitylhs
==
rhs
.
- jWSExpr: DoubleFloat -> %
jWSExpr(r)
returns the DoubleFloat as a JuliaWSExpression.
- jWSExpr: Float -> %
jWSExpr(r)
returns the Floatr
as a JuliaWSExpression.
- jWSExpr: Integer -> %
jWSExpr(z)
returns the Integerz
as a JuliaWSExpression.
- jWSExpr: JuliaFloat64 -> %
jWSExpr(r)
returns theJuliaFloat64
as a JuliaWSExpression.
- jWSExpr: List % -> %
jWSExpr(list)
returns thelist
of JuliaWSExpression as a JuliaWSExpression.
- jWSExpr: String -> %
jWSExpr(str)
constructsstr
as a JuliaWSExpression evaluatingstr
as a Wolfram Symbolic Language Expression. For example: example{jWSExpr “Factorial[5]”} example{jWSExpr “3.14159”} example{jWSExpr “Today”}
- jWSExpr: Symbol -> %
jWSExpr(sym)
coercessym
to a JuliaWSExpression.
- jWSGreater: (%, %) -> %
jWSGreater(lhs,rhs)
returns the JuliaWS
inequalitylhs
>rhs
.
- jWSGreaterEqual: (%, %) -> %
jWSGreaterEqual(lhs,rhs)
returns the JuliaWS
inequalitylhs
>=
rhs
.
- jWSInterpret: (String, String) -> %
from JuliaWSObject
- jWSLess: (%, %) -> %
jWSLess(lhs,rhs)
returns the JuliaWS
inequalitylhs
<rhs
.
- jWSLessEqual: (%, %) -> %
jWSLessEqual(lhs,rhs)
returns the JuliaWS
inequalitylhs
<=
rhs
.
- jWSNotEqual: (%, %) -> %
jWSNotEqual(lhs,rhs)
returns the JuliaWS
inequalitylhs
!=
rhs
.
- jWSQuantity: % -> %
jWSQuantity(jWSString(u))
returns quantity unitu
of 1. For example: example{jWSQuantity jWSString “Meter”}
- jWSQuantity: (%, %) -> %
jWSQuantity(x,jWSString(u))
returns quantity unitu
ofx
. For example: example{jWSQuantity(1.2, jWSString “Meter”)}
- jWSRule: (%, %) -> %
jWSRule(lhs,rhs)
returns the JuliaWS
rulelhs
->rhs.
- jWSString: String -> %
jWSString(str)
returnsstr
as aWS
String.
- jWSTable: (%, %) -> JuliaWSList %
jWSTable(expr, range)
applies theexpr
to the define range.
- jWSTable: (%, %, %) -> JuliaWSList JuliaWSList %
jWSTable(expr, range1, range2)
applies theexpr
to the define ranges.
- kelvinBei: (%, %) -> %
- kelvinBer: (%, %) -> %
- kelvinKei: (%, %) -> %
- kelvinKer: (%, %) -> %
- kernel: (BasicOperator, %) -> %
from ExpressionSpace2 Kernel %
- kernel: (BasicOperator, List %) -> %
from ExpressionSpace2 Kernel %
- kernels: % -> List Kernel %
from ExpressionSpace2 Kernel %
- kernels: List % -> List Kernel %
from ExpressionSpace2 Kernel %
- key?: (%, %) -> Boolean
key?(assoc,key)
checks wheter or notkey
exist in the associationassoc
.
- keys: % -> %
keys(expr)
returns the key elements inexpr
if any.
- kleinInvariantJ: % -> %
kleinInvariantJ(tau)
computes the Klein's
absolute invariant.
- krawtchoukK: (%, %, %, %) -> %
- kummerM: (%, %, %) -> %
- kummerU: (%, %, %) -> %
- laguerreL: (%, %) -> %
laguerreL(n, x)
returns the laguerre polynomial or evaluates it atx
ifx
is a number. For example: example{laguerreL(5, jWSExpr x)}
- laguerreL: (%, %, %) -> %
laguerreL(n, a, x)
returns the genralized laguerre polynomial or evaluates it atx
ifx
is a number.
- lambertW: % -> %
- lambertW: (%, %) -> %
lambertW(k,z)
returns thek
-th solution to LambertW function.
- last: % -> %
from JuliaWSAggregate %
- latex: % -> String
from SetCategory
- lcmCoef: (%, %) -> Record(llcm_res: %, coeff1: %, coeff2: %)
from LeftOreRing
- leftPower: (%, NonNegativeInteger) -> %
from MagmaWithUnit
- leftPower: (%, PositiveInteger) -> %
from Magma
- leftRecip: % -> Union(%, failed)
from MagmaWithUnit
- legendreP: (%, %) -> %
legendreP(n, x)
returns the legendre polynomial of the first kind or evaluates it atx
isx
a number.
- legendreP: (%, %, %) -> %
legendreP(n, m, x)
returns the associated Legendre polynomial of the first type or evaluates it atx
ifx
is a number.
- legendreQ: (%, %) -> %
legendreQ(n, x)
returns the Legendre function of the second kind or evaluates it atx
ifx
is a number. example{legendreQ(3,jWSExpr x)}
- legendreQ: (%, %, %) -> %
legendreQ(n, m, x)
returns the associated Legendre function of the second kind or evaluates it atx
ifx
is a number.
- length: % -> %
length(expr)
returns the length ofexpr
seen as a list.- length: % -> JuliaWSInteger
from JuliaWSAggregate %
- lerchPhi: (%, %, %) -> %
lerchPhi(z,s,a)
returns Lerch's
transcendent phi of arguments.
- level: (%, %) -> JuliaWSList %
level(expr, lev)
returns the list of expressionexpr
at level lev.
- level: (%, %, Boolean) -> JuliaWSList %
level(expr, lev, head)
returns the list of expressionexpr
at levellev
with heads if head istrue
.
- li: % -> %
- lift: % -> SparseUnivariatePolynomial %
from MonogenicAlgebra(%, SparseUnivariatePolynomial %)
- limit: (%, %) -> %
limit(expr, params)
returns the limit, eventually nested or multivariate, ofexpr
. For example: example{x:=jWSExpr x; limit(sin(x)-sin(x-1/x),”x->Infinity”)}
- log10: % -> %
log10(x)
computes logarithm ofx
in base 10.
- log2: % -> %
log2(x)
computes logarithm ofx
in base 2.
- log: % -> %
- logBarnesG: % -> %
logBarnesG(x)
is the logarithm of Barnes-G
.
- logGamma: % -> %
logGamma(z)
returns the log-gamma ofz
.
- lommelS1: (%, %, %) -> %
- lommelS2: (%, %, %) -> %
- lookup: % -> PositiveInteger if % has Finite
from Finite
- lookup: (%, %) -> %
lookup(assocs,keys)
returns value(s
) associated to key(s
).
- lookup: (%, %, %) -> %
lookup(assocs,keys, defaultval)
returns value(s
) associated to key(s
) if key(s
) exist(s
), otherwise defaultval
- mainKernel: % -> Union(Kernel %, failed)
from ExpressionSpace2 Kernel %
- map: (% -> %, %) -> %
from FullyEvalableOver %
- map: (% -> %, Kernel %) -> %
from ExpressionSpace2 Kernel %
- mathieuC: (%, %, %) -> %
mathieuC(a,q,z)
is the even Mathieu function with characteristic a and parameterq
.
- mathieuCharacteristicA: (%, %) -> %
mathieuCharacteristicA(r,q)
returns the characteristic for even Mathieu function.
- mathieuCharacteristicB: (%, %) -> %
mathieuCharacteristicB(r,q)
returns the characteristic for odd Mathieu function.
- mathieuCharacteristicExponent: (%, %) -> %
mathieuCharacteristicExponent(a,q)
returns the characterisitc exponento
he Mathieu function.
- mathieuCPrime: (%, %, %) -> %
mathieuCPrime(a,q,z)
derivative of the even Mathieu function.
- mathieuS: (%, %, %) -> %
mathieuS(b,q,z)
is the odd Mathieu function with characteristicb
and parameterq
.
- mathieuSPrime: (%, %, %) -> %
mathieuSPrime(b,q,z)
derivative of the odd Mathieu function.
- matrixForm: % -> %
matrixForm(mat)
returns a pretty-printable form ofmat
i.e. itsWS
‘MatrixForm’.
- maximize: (%, %) -> %
maximize(expr, vars)
is theWS
symbolic maximization function.expr
can contain constraints if it is aWS
list of constraints with function to maximize as the first element. Global optimization function otherwise.
- maximize: (%, %, %) -> %
maximize(expr, vars, dom)
is theWS
symbolic maximization function. dom restricts the domain of variables, for example, Integers.
- maximize: (%, Symbol) -> %
maximize(expr, sym)
symbolically maximizes expression functionexpr
with respect tosym
.expr
can contain constraints if it is aWS
list of constraints with function to maximize as the first element. Global optimization function otherwise.
- maxLimit: (%, %) -> %
maxLimit(expr, params)
returns the max limit, eventually nested or multivariate, ofexpr
.
- meixnerM: (%, %, %, %) -> %
- meixnerP: (%, %, %, %) -> %
- member?: (%, %) -> Boolean
member?(list, expr)
checks if expr is inlist
.
- minimalPolynomial: % -> SparseUnivariatePolynomial %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- minimalPolynomial: (%, %) -> %
minimalPolynomial(expr,var)
returns the minimal polynomial in the variablevar
of the expressionexpr
.
- minimalPolynomial: (%, %, %) -> %
minimalPolynomial(expr,var, elem)
returns the minimal polynomial in the variablevar
of the expressionexpr
.
- minimize: (%, %) -> %
minimize(expr, vars)
is theWS
symbolic minimization function.expr
can contain constraints if it is aWS
list of constraints with function to minimize as the first element. Global optimization function otherwise.
- minimize: (%, %, %) -> %
minimize(expr, vars, dom)
is theWS
symbolic minimization function. dom restricts the domain of variables, for example, Integers.
- minimize: (%, Symbol) -> %
minimize(expr, sym)
symbolically minimizes expression functionexpr
with respect tosym
.expr
can contain constraints if it is aWS
list of constraints with function to minimize as the first element. Global optimization function otherwise.
- minLimit: (%, %) -> %
minLimit(expr, params)
returns the min limit, eventually nested or multivariate, ofexpr
.
- minPoly: Kernel % -> SparseUnivariatePolynomial %
from ExpressionSpace2 Kernel %
- modularLambda: % -> %
modularLambda()
computes the lambda modular function.
- monomialList: % -> %
monomialList(p)
returns the list of monomials inp
.
- multiEuclidean: (List %, %) -> Union(List %, failed)
from EuclideanDomain
- mutable?: % -> Boolean
from JuliaObjectType
- negative?: % -> Boolean
negative?(expr)
checks whether or notexpr
is negative.
- norm: % -> %
from ComplexCategory %
- normal: % -> %
normal(expr)
convertsexpr
to a normal expression from different expression types. Can be applied to a power serie for example.
- normal: (%, %) -> %
normal(expr, list(Head)||Head)
converts objects inexpr
to a normal expression form from different expression types, with Head, or a list of Head-s
.
- nothing?: % -> Boolean
from JuliaObjectType
- nthRoot: (%, Integer) -> %
from RadicalCategory
- numer: % -> SparseMultivariatePolynomial(%, Kernel %)
from FunctionSpace2(%, Kernel %)
- numerator: % -> %
numerator(expr)
returns the numerator ofexpr
.
- numerDenom: % -> JuliaWSList %
numerDenom(expr)
returns the numerator and denominator ofexpr
.
- numericDSolve: (%, %, %) -> %
numericDSolve(expr,fun,xrange)
solves numerically the differential equation(s
) inexpr
for the functionfun
, in the rangexrange
. Other combinaisons of parameters are also available.
- numericDSolve: (%, %, %, %) -> %
numericDSolve(expr,fun,xrange,yrange)
solves numerically the differential equation(s
) inexpr
for the functionfun
, in the rangesxrange
andyrange
. Other combinaisons of parameters are also available (see documentation).
- numericDSolve: (Equation %, %, %) -> %
numericDSolve(eq,fun,xrange)
solves numerically the differential equationeq
for the functionfun
, in the rangexrange
.
- numericDSolveValue: (%, %, %) -> %
numericDSolveValue(expr,fun,xrange)
returns the numerical value solution of the differential equation(s
) inexpr
for the functionfun
, in the rangexrange
. Other combinaisons of parameters are also available (see documentation).
- numericDSolveValue: (%, %, %, %) -> %
numericDSolveValue(expr,fun,xrange,yrange)
returns the numerical solution of the differential equation(s
) inexpr
for the functionfun
, in the rangesxrange
andyrange
. Other combinaisons of parameters are also available (see documentation).
- numericDSolveValue: (Equation %, %, %) -> %
numericDSolveValue(eq,fun,xrange)
return the numerical solution of the differential equationeq
for the functionfun
, in the rangexrange
.
- numericIntegrate: (%, %) -> %
numericIntegrate(expr, opt|var)
integrate numericallyexpr
with respect to opt or var as options.
- numericIntegrate: (%, %, Segment Integer) -> %
numericIntegrate(expr, var, seg)
integratesexpr
using segment seg with respect tovar
.
- numericMaximize: (%, %) -> %
numericMaximize(expr, vars)
maximizes numerically the expression functionexpr
with respect to vars.
- numericMaximize: (%, %, %) -> %
numericMaximize(expr, vars, dom)
maximizes numerically the expression functionexpr
with respect tovars
andvars
restricted to the domain dom.
- numericMaximize: (%, Symbol) -> %
numericMaximize(expr, sym)
maximizes numerically the expression functionexpr
with respect tosym
.
- numericMinimize: (%, %) -> %
numericMinimize(expr, vars)
minimizes numerically the expression functionexpr
with respect to vars. For example, global optimization from the SIAM 100 digits challenge: example{x := jWSExpr(x);y:=jWSExpr y;} example{expr := exp(sin(50*x))+sin(60*exp(y))+ sin(70*sin(x))+ sin(sin(80*y))-sin(10*(x+y))+(x^2+y^2)/4} example{numericMinimize(expr, jWSList [x,y])}
- numericMinimize: (%, %, %) -> %
numericMinimize(expr, vars, dom)
minimizes numerically the expression functionexpr
with respect tovars
andvars
restricted to the domain dom.
- numericMinimize: (%, Symbol) -> %
numericMinimize(expr, sym)
minimizes numerically the expression functionexpr
with respect tosym
.
- numericProduct: (%, %) -> %
numericProduct(f(n),range)
an evaluated numerical approximation of the sumf
(imin) + .. +f
(imax) defined by the listrange
, for example example{jWSExpr(”{i, imin, imax}”)}. See Wolfram language specifications.
- numericProduct: (%, %, Segment Integer) -> %
numericProduct(f(n),n, a..b)
returns an evaluated numerical approximation productf
(a) *f
(a2
) * .. *f
(b
).
- numericSolve: (%, %) -> %
numericSolve(expr, vars)
returns the solution(s
) to the expressionexpr
.
- numericSolve: (Equation %, %) -> %
numericSolve(eq, vars)
returns the solution(s
) to the equationeq
.
- numericSum: (%, %) -> %
numericSum(f(n),range)
an evaluated numerical approximation of the sumf
(imin) + .. +f
(imax) defined by the listrange
, for example example{jWSExpr(”{i, imin, imax}”)}. See Wolfram language specifications.
- numericSum: (%, %, Segment Integer) -> %
numericSum(f(n),n, a..b)
returns an evaluated numerical approximation sumf
(a) +f
(a2
) + .. +f
(b
).
- one?: % -> Boolean
from MagmaWithUnit
- operator: BasicOperator -> BasicOperator
from ExpressionSpace2 Kernel %
- operators: % -> List BasicOperator
from ExpressionSpace2 Kernel %
- opposite?: (%, %) -> Boolean
from AbelianMonoid
- padeApproximant: (%, %) -> %
padeApproximant(expr, {x,x0, {n,m}})
returns the Padé approximant atx0
.
- parabolicCylinderD: (%, %) -> %
parabolicCylinderD(nu,x)
computes the parabolic cylinder functionD
ofx
.
- paren: % -> %
from ExpressionSpace2 Kernel %
- part: (%, JuliaWSInteger) -> %
from JuliaWSAggregate %
- permutation: (%, %) -> %
- pi: () -> %
- plenaryPower: (%, PositiveInteger) -> %
from NonAssociativeAlgebra %
- pochhammer: (%, %) -> %
pochhammer(a,n)
returns the Pochhammer symbol.
- polygamma: (%, %) -> %
- polylog: (%, %) -> %
- polylog: (%, %, %) -> %
polylog(n,p,x)
is the Nielsen generalized polylogarithm function.
- polynomial?: (%, %) -> Boolean
polynomial?(p,x)
check whether or notp
is a polynomial inx
.
- polynomial?: (%, JuliaWSList %) -> Boolean
polynomial?(p,vlist)
check whether or notp
is a polynomial in the list of variablesvlist
.
- polynomialExtendedGCD: (%, %, %) -> %
polynomialExtendedGCD(p1, p2, x)
returns the greatest common divisor ofp1
andp2
considered as univariate polynomial inx
- polynomialFactor: % -> %
polynomialFactor(p)
factorizes the polynomialp
. For example: example{x := jWSExpr x} example{p:=expand(chebyshevT(7,x)* chebyshevU(9,x))} example{polynomialFactor p}
- polynomialGCD: (%, %) -> %
polynomialGCD(p1, p2)
returns the greatest common divisor ofp1
andp2
.
- polynomialGCD: (%, %, %) -> %
polynomialGCD(p1, p2, opt)
returns the greatest common divisor ofp1
andp2
with options opt, for example Modulus->p
.
- polynomialLCM: (%, %) -> %
polynomialLCM(p1,p2)
returns the least common divisor ofp1
andp2
.
- polynomialLCM: (%, %, %) -> %
polynomialLCM(p1,p2,opt)
returns the least common divisor ofp1
andp2
with optionsopt
, for example an Extension rule.
- polynomialMod: (%, %) -> %
polynomialMod(p,mod)
reduces modulop
the intger coefficients of the polynomialp
.
- polynomialQuotient: (%, %, %) -> %
polynomialQuotient(p1, p2, x)
returns the quotient ofp1
andp2
inx
.
- polynomialQuotientRemainder: (%, %, %) -> JuliaWSList %
polynomialQuotientRemainder(p1,p2,var)
returns the quotient and remainder ofp1
andp2
inx
.
- polynomialReduce: (%, %, %) -> %
polynomialReduce(poly,lpoly,lvar)
returns a minimal representation of the polynomialpoly
in terms of the polynomial listlpoly
with respect to the list of variableslvar
.
- polynomialRemainder: (%, %, %) -> %
polynomialRemainder(p1,p2, x)
returns the remainder ofp1
andp2
inx
.
- positive?: % -> Boolean
positive?(expr)
checks whether or notexpr
is positive.
- positiveInfinity: () -> %
positiveInfinity()
returns positive infinity (∞).
- powerExpand: % -> %
powerExpand(expr)
expands powers inexpr
assuming no branch cut.
- powerExpand: (%, %) -> %
powerExpand(expr, sym)
expands powers inexpr
with respect tosym
, assuming no branch cut.
- prepend: (%, %) -> %
from JuliaWSAggregate %
- principalIdeal: List % -> Record(coef: List %, generator: %)
from PrincipalIdealDomain
- product: (%, %) -> %
product(f(n),range)
returns the productf
(imin) * .. *f
(imax) defined by the listrange
, for example example{jWSExpr(”{i, imin, imax}”)}. See Wolfram language specifications.
- product: (%, %, Segment Integer) -> %
product(f(n),n, a..b)
returns the productf
(a) * .. *f
(b
).- product: (%, SegmentBinding %) -> %
- product: (%, Symbol) -> %
product(f(n),n)
returns the indefinite product off
(n
).
- QBinomial: (%, %, %) -> %
QBinomial(n,m,q)
returns theq
-analog of binomial coefficient.
- qelt: (%, Integer) -> %
from JuliaWSAggregate %
- QFactorial: (%, %) -> %
QFactorial(x,q)
returns theq
-analog of factorial ofx
.
- QGamma: (%, %) -> %
QGamma(x,q)
returns theq
-analog of Euler gamma ofx
.
- QPochhammer: (%, %) -> %
QPochhammer(x,q)
returns theq
-Pochammer symbol ofx
.
- QPochhammer: (%, %, %) -> %
QPochhammer(x,q,n)
returns theq
-Pochammer symbol ofx
.
- QPolyGamma: (%, %) -> %
QPolyGamma(x,q)
returs theq
-digamma ofx
.
- QPolyGamma: (%, %, %) -> %
QPolyGamma(n,x,q)
returns then
-th derivative of theq
-digamma function ofx
.
- qsetelt!: (%, Integer, %) -> %
from JuliaWSAggregate %
- qsetelt: (%, Integer, %) -> %
from JuliaWSAggregate %
- quantityForm: (%, %) -> %
quantityForm(expr,form)
returnsexpr
as a quantity with formatform
.
- quantityForm: (%, JuliaWSList %) -> %
quantityForm(expr,lform)
returnsexpr
as a quantity with a list of formatslform
.
- quantityMagnitude: % -> %
quantityMagnitude(val)
returns magnitude ofval
.
- quantityUnit: % -> %
quantityUnit(val)
returns unit ofval
.
- quo: (%, %) -> %
from EuclideanDomain
- racahR: (%, %, %, %, %, %) -> %
- ramanujanTau: % -> %
ramanujanTau(n)
returns the Ramanujan tau ofn
.
- ramanujanTauL: % -> %
ramanujanTauL(s)
computes the Ramanujan tau DirichletL
-function ofs
.
- ramanujanTauTheta: % -> %
ramanujanTauTheta(z)
returns the Ramanujan tau theta ofz
.
- ramanujanTauZ: % -> %
ramanujanTauZ(t)
computes the Ramanujan tauZ
-function oft
.
- rank: () -> PositiveInteger
from FramedModule %
- rationalApproximation: % -> %
rationalApproximation(expr)
try to find a rational approximation of the expressionexpr
.
- rationalApproximation: (%, %) -> %
rationalApproximation(expr, dx)
try to find a rational approximation of the expressionexpr
within tolerancedx
.
- real: % -> %
from ComplexCategory %
- recip: % -> Union(%, failed)
from MagmaWithUnit
- reduce: (%, %) -> %
reduce(expr,lvars)
tries to reduce the (in)equation inexpr
.
- reduce: (%, %, %) -> %
reduce(expr,lvars,dom)
tries to reduce the (in)equation inexpr
.
- reduce: (%, String, %, %) -> %
reduce(lhs, rel, rhs,lvars)
tries to reduce the (in)equation in expr whererel
is the relation operator (“==” or “<=” for example).
- reduce: (%, String, %, %, %) -> %
reduce(lhs, rel,rhs,lvars,dom)
tries to reduce the (in)equation in expr whererel
is the relation operator ("="
or “<=” for example).
- reduce: (Equation %, %) -> %
reduce(expr,lvars)
tries to reduce the equation inexpr
.
- reduce: (Equation %, %, %) -> %
reduce(expr,lvars,dom)
tries to reduce the equation inexpr
.- reduce: Fraction SparseUnivariatePolynomial % -> Union(%, failed)
from MonogenicAlgebra(%, SparseUnivariatePolynomial %)
- reduce: SparseUnivariatePolynomial % -> %
from MonogenicAlgebra(%, SparseUnivariatePolynomial %)
- reducedSystem: (Matrix %, Vector %) -> Record(mat: Matrix %, vec: Vector %)
from LinearlyExplicitOver %
- reducedSystem: Matrix % -> Matrix %
from LinearlyExplicitOver %
- refine: (%, %) -> %
refine(expr, assums)
refines the expressionexpr
with assumptions assums.
- regularRepresentation: % -> Matrix %
from FramedAlgebra(%, SparseUnivariatePolynomial %)
- regularRepresentation: (%, Vector %) -> Matrix %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- rem: (%, %) -> %
from EuclideanDomain
- removeDuplicates: % -> %
from JuliaWSAggregate %
- replace: (%, %) -> %
replace(expr, rule)
applies rule(s
) toexpr
.
- replace: (%, %, %) -> %
replace(expr, rule, lev)
appliesrule
toexpr
with level lev.
- replaceAll: (%, %) -> %
replaceAll(expr, rule)
applies rule(s
) toexpr
.
- replaceAt: (%, %, %) -> %
replaceAt(expr, part, n)
replaces then
-th element ofexpr
using rule(s
).
- replacePart: (%, %) -> %
replacePart(expr, part)
replacesexpr
using rule(s
) expressing position(s
).
- replaceRepeated: (%, %) -> %
replaceRepeated(expr, rule)
applies rule(s
) toexpr
, but repeatedly.
- represents: (Vector %, Vector %) -> %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- represents: Vector % -> %
from FramedModule %
- residue: (%, %) -> %
residue(expr, {x,x0})
returns the residue ofexpr
atx0
.
- residueSum: (%, %) -> %
residueSum(expr, var)
returns the residue ofexpr
. example{residueSum(Gamma(x),x)}
- rest: % -> %
from JuliaWSAggregate %
- resultant: (%, %, %) -> %
resultant(p1,p2,x)
returns the resultant ofp1
andp2
.
- retract: % -> %
from RetractableTo %
- retract: % -> Expression Integer
retract(expr)
tries to retractexpr
to an Expression(Integer). Throws an error otherwise.- retract: % -> Fraction Integer if % has RetractableTo Integer or % has RetractableTo Fraction Integer
from RetractableTo Fraction Integer
- retract: % -> Fraction Polynomial %
from RetractableTo Fraction Polynomial %
- retract: % -> Kernel %
from RetractableTo Kernel %
- retract: % -> Polynomial %
from RetractableTo Polynomial %
- retract: % -> Symbol
from RetractableTo Symbol
- retractIfCan: % -> Union(%, failed)
from RetractableTo %
- retractIfCan: % -> Union(DoubleFloat, failed)
retractIfCan(expr)
retractsexpr
to a DoubleFloat if it can be retracted to a Lisp machine float.
- retractIfCan: % -> Union(Expression Integer, failed)
retractIfCan(expr)
tries to retractexpr
to an Expression(Integer).- retractIfCan: % -> Union(Fraction Integer, failed) if % has RetractableTo Integer or % has RetractableTo Fraction Integer
from RetractableTo Fraction Integer
- retractIfCan: % -> Union(Fraction Polynomial %, failed)
from RetractableTo Fraction Polynomial %
- retractIfCan: % -> Union(JuliaFloat64, failed)
retractIfCan(expr)
retractsexpr
to aJuliaFloat64
if it can be retracted to a 64 bits machine float.- retractIfCan: % -> Union(Kernel %, failed)
from RetractableTo Kernel %
- retractIfCan: % -> Union(Polynomial %, failed)
from RetractableTo Polynomial %
- retractIfCan: % -> Union(Symbol, failed)
from RetractableTo Symbol
- reverse: % -> %
from JuliaWSAggregate %
- reverse: (%, JuliaWSInteger) -> %
from JuliaWSAggregate %
- reverse: (%, JuliaWSList JuliaWSInteger) -> %
from JuliaWSAggregate %
- riemannSiegelTheta: % -> %
riemannSiegelTheta(t)
returns the Riemann-Siegel theta function oft
.
- riemannSiegelZ: % -> %
riemannSiegelZ(t)
computes the Riemann-SiegelZ
function oft
.
- riemannZeta: % -> %
- riemannZeta: (%, %) -> %
riemannZeta(s,a)
is the generalized Riemann zeta function.
- riffle: (%, %) -> %
from JuliaWSAggregate %
- riffle: (%, %, %) -> %
from JuliaWSAggregate %
- rightPower: (%, NonNegativeInteger) -> %
from MagmaWithUnit
- rightPower: (%, PositiveInteger) -> %
from Magma
- rightRecip: % -> Union(%, failed)
from MagmaWithUnit
- rootOf: % -> %
- rootOf: (%, Symbol) -> %
- rootOf: (SparseUnivariatePolynomial %, Symbol) -> %
- rootOf: Polynomial % -> %
- rootOf: SparseUnivariatePolynomial % -> %
- rootReduce: % -> %
rootReduce(expr)
reduces root functions.
- rootsOf: % -> List %
- rootsOf: (%, Symbol) -> List %
- rootsOf: (SparseUnivariatePolynomial %, Symbol) -> List %
- rootsOf: Polynomial % -> List %
- rootsOf: SparseUnivariatePolynomial % -> List %
- rootSum: (%, SparseUnivariatePolynomial %, Symbol) -> %
- round: % -> %
round(x)
returns the integer closest tox
.
- sample: %
from AbelianMonoid
- sec: % -> %
- sech: % -> %
- series: (%, %) -> %
series(expr, opt)
returns a serie fromexpr
. example{x:=jWSExpr(x)} example{opt:=jWSList [x,pi
()$JWSEXPR/4,7]} example{series(sin(a*x),opt)} example{series(cos(x),”{x, 0, 12}”)}
- setelt!: (%, Integer, %) -> %
from JuliaWSAggregate %
- setelt: (%, Integer, %) -> %
from JuliaWSAggregate %
- setIntersection: (%, %) -> %
from JuliaWSAggregate %
- Shi: % -> %
- Si: % -> %
- siegelTheta: (%, %) -> %
siegelTheta(tau, s)
computes the Siegel theta function.
- siegelTheta: (%, %, %) -> %
siegelTheta(nu, tau, s)
computes the Siegel theta function.
- sign: % -> %
- simplify: % -> %
simplify(expr)
simplifies theexpr
. example{x:=jWSExpr(“x”); simplify(sqrt(x^2)^2)}
- simplify: (%, %) -> %
simplify(expr, assumptions)
simplifies the expressionexpr
assuming that assumptions are satisfied. For example: example{x:=jWSExpr(“x”); simplify(sqrt(x^2), “x>0”)}
- sin: % -> %
- sinc: % -> %
sinc(x)
computes the unormalized sinc ofx
, sin(x
)/x
and 0 ifx
= 0.
- sinh: % -> %
- size: () -> NonNegativeInteger if % has Finite
from Finite
- sizeLess?: (%, %) -> Boolean
from EuclideanDomain
- smaller?: (%, %) -> Boolean
from Comparable
- solve: (%, %) -> JuliaWSList JuliaWSList %
solve(expr, vars)
tries to solve the expressionexpr
.
- solve: (%, %, %) -> JuliaWSList JuliaWSList %
solve(expr, vars, dom)
tries to solve the expressionexpr
.
- solve: (%, String, %, %) -> JuliaWSList JuliaWSList %
solve(lhs, rel, rhs,lvars)
tries to solve the (in)equation in expr whererel
is the relation operator (“==” for example).
- solve: (%, String, %, %, %) -> JuliaWSList JuliaWSList %
solve(lhs, rel,rhs,lvars,dom)
tries to solve the (in)equation in expr whererel
is the relation operator (“==” for example).
- solve: (Equation %, %) -> JuliaWSList JuliaWSList %
solve(eq, vars)
tries to solve the equationeq
.
- solve: (Equation %, %, %) -> JuliaWSList JuliaWSList %
solve(expr, vars, dom)
tries to solve the expressionexpr
.
- solveLinearPolynomialEquation: (List SparseUnivariatePolynomial %, SparseUnivariatePolynomial %) -> Union(List SparseUnivariatePolynomial %, failed) if % has PolynomialFactorizationExplicit
- sort: % -> %
from JuliaWSAggregate %
- sorted?: % -> Boolean
from JuliaWSAggregate %
- sphericalBesselJ: (%, %) -> %
sphericalBesselJ(n,z)
returns the spherical Bessel of the first kind ofz
.
- sphericalBesselY: (%, %) -> %
sphericalBesselY(n,z)
returns the spherical Bessel of the second kind ofz
.
- sphericalHankelH1: (%, %) -> %
sphericalHankelH1(n,z)
returns the spherical Hankel of the first kind ofz
.
- sphericalHankelH2: (%, %) -> %
sphericalHankelH2(n,z)
computes the spherical Hankel of the second kind ofz
.
- sphericalHarmonicY: (%, %, %, %) -> %
sphericalHarmonicY(l, m, theta, phi)
returns the spherical harmonicY
or evaluates it.
- sqrt: % -> %
from RadicalCategory
- squareFree: % -> Factored %
- squareFreePart: % -> %
- squareFreePolynomial: SparseUnivariatePolynomial % -> Factored SparseUnivariatePolynomial % if % has PolynomialFactorizationExplicit
- stieltjesGamma: % -> %
stieltjesGamma(n)
returns then
-th Stieltjes constant.
- stieltjesGamma: (%, %) -> %
stieltjesGamma(n,a)
returns the generalizedn
-th Stieltjes constant.
- string: % -> String
from JuliaObjectType
- struveH: (%, %) -> %
- struveL: (%, %) -> %
- subResultants: (%, %, %) -> %
subResultants(p1,p2,x)
returns the subresultant ofp1
andp2
with respect tox
.
- subst: (%, Equation %) -> %
from ExpressionSpace2 Kernel %
- subst: (%, List Equation %) -> %
from ExpressionSpace2 Kernel %
- subst: (%, List Kernel %, List %) -> %
from ExpressionSpace2 Kernel %
- subtractIfCan: (%, %) -> Union(%, failed)
- sum: (%, %) -> %
sum(f(n),range)
returns the sumf
(imin) + .. +f
(imax) defined by the listrange
, for example example{jWSExpr(”{i, imin, imax}”)}. See Wolfram Language specifications.
- sum: (%, Symbol) -> %
sum(f(n),n)
returns the indefinite sum off
(n
).
- summation: (%, SegmentBinding %) -> %
- summation: (%, Symbol) -> %
- symmetricPolynomial: (%, JuliaWSList %) -> %
symmetricPolynomial(n,lvars)
returns then
-th elementary symmetric polynomial with respect to variables inlvars
.
- symmetricReduction: (%, JuliaWSList %) -> JuliaWSList %
symmetricReduction(f,lvars)
return a pair of polynomial representingf
=p+q
wherep
is a symmetric polynomial,q
the remainder.
- symmetricReduction: (%, JuliaWSList %, JuliaWSList %) -> JuliaWSList %
symmetricReduction(f, lvars, replnt)
return a pair of polynomial representingf
=p+q
wherep
is a symmetric polynomial,q
the remainder where variables inp
replaced by the ones in replnt.
- take: (%, Integer) -> %
from JuliaWSAggregate %
- take: (%, JuliaWSList JuliaWSInteger) -> %
from JuliaWSAggregate %
- tan: % -> %
- tanh: % -> %
- together: % -> %
together(expr)
put together terms over a common denominator cancelling common factors in numerator and denominator.
- toString: % -> String
from JuliaWSObject
- toString: (%, %) -> String
toString(expr, form)
returns the string representation ofexpr
withWS
language format form.
- tower: % -> List Kernel %
from ExpressionSpace2 Kernel %
- tower: List % -> List Kernel %
from ExpressionSpace2 Kernel %
- trace: % -> %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- traceMatrix: () -> Matrix %
from FramedAlgebra(%, SparseUnivariatePolynomial %)
- traceMatrix: Vector % -> Matrix %
from FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
- traditionalForm: % -> %
traditionalForm(expr)
returns a traditional form ofexpr
i.e. itsWS
‘TraditionalForm’.
- trigExpand: % -> %
trigExpand(expr)
tries to expand (hyperbolic) trigonometric functions inexpr
.
- trigFactor: % -> %
trigFactor(expr)
factors (hyperbolic) trigonometric functions inexpr
.
- trigFactorList: % -> JuliaWSList %
trigFactorList(expr)
returns a list of factors of (hyperbolic) trigonometric functions inexpr
.
- trigReduce: % -> %
trigReduce(expr)
reduces power and products of trigonometric functions.
- trigToExp: % -> %
trigToExp(expr)
returnsexpr
with (hyperbolic) trigonometric functions converted to, evetually complex, exponentials.
- union: (%, %) -> %
from JuliaWSAggregate %
- unit?: % -> Boolean
from EntireRing
- unitCanonical: % -> %
from EntireRing
- unitNormal: % -> Record(unit: %, canonical: %, associate: %)
from EntireRing
- unitStep: % -> %
- univariate: (%, Kernel %) -> Fraction SparseUnivariatePolynomial %
from FunctionSpace2(%, Kernel %)
- values: % -> %
values(expr)
returns the values elements inexpr
.
- variables: % -> JuliaWSList %
variables(p)
returns the list of variables inp
.- variables: % -> List Symbol
from FunctionSpace2(%, Kernel %)
- variables: List % -> List Symbol
from FunctionSpace2(%, Kernel %)
- weberE: (%, %) -> %
- weierstrassP: (%, %, %) -> %
- weierstrassPInverse: (%, %, %) -> %
- weierstrassPPrime: (%, %, %) -> %
- weierstrassSigma: (%, %, %) -> %
- weierstrassZeta: (%, %, %) -> %
- whittakerM: (%, %, %) -> %
whittakerM(k,m,x)
computes the Whittaker functionM
dex
.
- whittakerW: (%, %, %) -> %
whittakerW(k,m,z)
computes the Whittaker functionW
dex
.
- wilsonW: (%, %, %, %, %, %) -> %
- zernikeR: (%, %, %) -> %
zernikeR(n, m, x)
returns the Zernike radial polynomial or evaluates it atx
ifx
is a number.
- zero?: % -> Boolean
zero? x
tries to determine ifx
is 0. For example: example{expr:=0$JWSEXPR/1*sqrt(17::JWSEXPR); zero? expr}
- zeroOf: % -> %
- zeroOf: (%, Symbol) -> %
- zeroOf: (SparseUnivariatePolynomial %, Symbol) -> %
- zeroOf: Polynomial % -> %
- zeroOf: SparseUnivariatePolynomial % -> %
- zerosOf: % -> List %
- zerosOf: (%, Symbol) -> List %
- zerosOf: (SparseUnivariatePolynomial %, Symbol) -> List %
- zerosOf: Polynomial % -> List %
- zerosOf: SparseUnivariatePolynomial % -> List %
Algebra %
AlgebraicallyClosedFunctionSpace %
ArcTrigonometricFunctionCategory
BiModule(%, %)
BiModule(Fraction Integer, Fraction Integer)
CoercibleFrom Fraction Integer if % has RetractableTo Integer or % has RetractableTo Fraction Integer
CoercibleFrom Fraction Polynomial %
ConvertibleTo SparseUnivariatePolynomial %
Evalable %
FiniteRankAlgebra(%, SparseUnivariatePolynomial %)
FramedAlgebra(%, SparseUnivariatePolynomial %)
FunctionSpace2(%, Kernel %)
InnerEvalable(%, %)
InnerEvalable(Kernel %, %)
Module %
MonogenicAlgebra(%, SparseUnivariatePolynomial %)
NonAssociativeAlgebra Fraction Integer
PartialDifferentialRing Symbol
PolynomialFactorizationExplicit
RetractableTo Fraction Polynomial %