diff options
author | dos-reis <gdr@axiomatics.org> | 2009-05-29 19:09:54 +0000 |
---|---|---|
committer | dos-reis <gdr@axiomatics.org> | 2009-05-29 19:09:54 +0000 |
commit | c39287d87b632b3582b0e179b08d44dc6c27510f (patch) | |
tree | 88c661ea1bd325ad74b4f3f472c052687e8ca1d4 /src/algebra | |
parent | a17c2d47d4df5af5ef5e624ac6c5636b2741dd4a (diff) | |
download | open-axiom-c39287d87b632b3582b0e179b08d44dc6c27510f.tar.gz |
* algebra/algext.spad.pamphlet: Qualify `characteristic'.
* algebra/clifford.spad.pamphlet: Likewise.
* algebra/complet.spad.pamphlet: Likewise.
* algebra/contfrac.spad.pamphlet: Likewise.
* algebra/curve.spad.pamphlet: Likewise.
* algebra/ddfact.spad.pamphlet: Likewise.
* algebra/derham.spad.pamphlet: Likewise.
* algebra/equation2.spad.pamphlet: Likewise.
* algebra/ffcat.spad.pamphlet: Likewise.
* algebra/ffcg.spad.pamphlet: Likewise.
* algebra/fff.spad.pamphlet: Likewise.
* algebra/ffnb.spad.pamphlet: Likewise.
* algebra/ffp.spad.pamphlet: Likewise.
* algebra/ffpoly.spad.pamphlet: Likewise.
* algebra/ffx.spad.pamphlet: Likewise.
* algebra/fmod.spad.pamphlet: Likewise.
* algebra/fortmac.spad.pamphlet: Likewise.
* algebra/fr.spad.pamphlet: Likewise.
* algebra/fraction.spad.pamphlet: Likewise.
* algebra/fspace.spad.pamphlet: Likewise.
* algebra/gaussian.spad.pamphlet: Likewise.
* algebra/gpol.spad.pamphlet: Likewise.
* algebra/intclos.spad.pamphlet: Likewise.
* algebra/interval.spad.pamphlet: Likewise.
* algebra/laurent.spad.pamphlet: Likewise.
* algebra/matrix.spad.pamphlet: Likewise.
* algebra/modring.spad.pamphlet: Likewise.
* algebra/oct.spad.pamphlet: Likewise.
* algebra/opalg.spad.pamphlet: Likewise.
* algebra/padic.spad.pamphlet: Likewise.
* algebra/perman.spad.pamphlet: Likewise.
* algebra/pf.spad.pamphlet: Likewise.
* algebra/pfr.spad.pamphlet: Likewise.
* algebra/poly.spad.pamphlet: Likewise.
* algebra/polycat.spad.pamphlet: Likewise.
* algebra/puiseux.spad.pamphlet: Likewise.
* algebra/quat.spad.pamphlet: Likewise.
* algebra/radix.spad.pamphlet: Likewise.
* algebra/reclos.spad.pamphlet: Likewise.
* algebra/resring.spad.pamphlet: Likewise.
* algebra/sf.spad.pamphlet: Likewise.
* algebra/si.spad.pamphlet: Likewise.
* algebra/solvefor.spad.pamphlet: Likewise.
* algebra/sups.spad.pamphlet: Likewise.
* algebra/taylor.spad.pamphlet: Likewise.
* algebra/vector.spad.pamphlet: Likewise.
* algebra/xpoly.spad.pamphlet: Likewise.
Diffstat (limited to 'src/algebra')
58 files changed, 223 insertions, 260 deletions
diff --git a/src/algebra/algext.spad.pamphlet b/src/algebra/algext.spad.pamphlet index 9a747687..050ccac5 100644 --- a/src/algebra/algext.spad.pamphlet +++ b/src/algebra/algext.spad.pamphlet @@ -75,7 +75,7 @@ SimpleAlgebraicExtension(R:CommutativeRing, coordinates(x) == [coefficient(lift(x),i) for i in 0..d1] represents(vect) == +/[monomial(vect.(i+1),i) for i in 0..d1] definingPolynomial() == M - characteristic() == characteristic()$R + characteristic == characteristic$R rank() == d::PositiveInteger basis() == copy(bsis@Vector(Rep) pretend Vector($)) --!! I inserted 'copy' in the definition of 'basis' -- cjw 7/19/91 diff --git a/src/algebra/clifford.spad.pamphlet b/src/algebra/clifford.spad.pamphlet index ecedf9ac..bbc0f75c 100644 --- a/src/algebra/clifford.spad.pamphlet +++ b/src/algebra/clifford.spad.pamphlet @@ -292,7 +292,7 @@ CliffordAlgebra(n, K, Q): T == Impl where c: K m: Integer - characteristic() == characteristic()$K + characteristic == characteristic$K dimension() == dim::CardinalNumber x = y == diff --git a/src/algebra/complet.spad.pamphlet b/src/algebra/complet.spad.pamphlet index 73cff0fb..d71d3f74 100644 --- a/src/algebra/complet.spad.pamphlet +++ b/src/algebra/complet.spad.pamphlet @@ -100,7 +100,7 @@ OrderedCompletion(R:SetCategory): Exports == Implementation where fininf: (B, R) -> % 1 == [1$R] - characteristic() == characteristic()$R + characteristic == characteristic$R fininf(b, r) == r > 0 => [b] @@ -242,7 +242,7 @@ OnePointCompletion(R:SetCategory): Exports == Implementation where fininf: R -> % 1 == 1$R - characteristic() == characteristic()$R + characteristic == characteristic$R fininf r == zero? r => error "Undefined product" diff --git a/src/algebra/contfrac.spad.pamphlet b/src/algebra/contfrac.spad.pamphlet index e24d5825..615d435a 100644 --- a/src/algebra/contfrac.spad.pamphlet +++ b/src/algebra/contfrac.spad.pamphlet @@ -220,7 +220,7 @@ ContinuedFraction(R): Exports == Implementation where d := qr.remainder [[wh, construct rest reverse_! l], true] - characteristic() == characteristic()$Q + characteristic == characteristic$Q genFromSequence apps == diff --git a/src/algebra/curve.spad.pamphlet b/src/algebra/curve.spad.pamphlet index 37d330ee..7b8e73ff 100644 --- a/src/algebra/curve.spad.pamphlet +++ b/src/algebra/curve.spad.pamphlet @@ -698,8 +698,8 @@ RadicalFunctionField(F, UP, UPUP, radicnd, n): Exports == Impl where startUp b == brandNew?() := b - if zero?(p := characteristic()$F) or p > n then char0StartUp() - else charPStartUp() + if zero?(p := characteristic$F) or p > n then char0StartUp() + else charPStartUp() dsc:RF := ((-1)$Z ** ((n *$N n1) quo 2::N) * (n::Z)**n)$Z * radicnd ** n1 * */[qelt(ibasis, i) ** 2 for i in mini..maxIndex ibasis] diff --git a/src/algebra/ddfact.spad.pamphlet b/src/algebra/ddfact.spad.pamphlet index f160ec23..df499007 100644 --- a/src/algebra/ddfact.spad.pamphlet +++ b/src/algebra/ddfact.spad.pamphlet @@ -82,7 +82,7 @@ DistinctDegreeFactorize(F,FP): C == T ddffact1 : (FP,Boolean) -> List fact ranpol : NNI -> FP - charF : Boolean := characteristic()$F = 2 + charF : Boolean := characteristic$F = 2 --construct a random polynomial of random degree < d ranpol(d:NNI):FP == diff --git a/src/algebra/derham.spad.pamphlet b/src/algebra/derham.spad.pamphlet index 6b77c0e6..404df940 100644 --- a/src/algebra/derham.spad.pamphlet +++ b/src/algebra/derham.spad.pamphlet @@ -266,7 +266,7 @@ AntiSymm(R:Ring, lVar:List Symbol): Export == Implement where m = 0 => 0 [ [Nul(dim), m::R] ] - characteristic() == characteristic()$R + characteristic == characteristic$R generator(j) == -- j < 1 or j > dim => error "your subscript is out of range" diff --git a/src/algebra/equation2.spad.pamphlet b/src/algebra/equation2.spad.pamphlet index e0d3bd30..a621d9f9 100644 --- a/src/algebra/equation2.spad.pamphlet +++ b/src/algebra/equation2.spad.pamphlet @@ -206,7 +206,7 @@ Equation(S: Type): public == private where leftOne eq == 1 = rhs eq * inv rhs eq rightOne eq == lhs eq * inv rhs eq = 1 if S has Ring then - characteristic() == characteristic()$S + characteristic == characteristic$S i:Integer * eq:$ == (i::S) * eq if S has IntegralDomain then factorAndSplit eq == diff --git a/src/algebra/ffcat.spad.pamphlet b/src/algebra/ffcat.spad.pamphlet index 2f3c1ba4..e7ae41ae 100644 --- a/src/algebra/ffcat.spad.pamphlet +++ b/src/algebra/ffcat.spad.pamphlet @@ -57,8 +57,8 @@ FieldOfPrimeCharacteristic:Category == _ ++ primeFrobenius(a,s) returns \spad{a**(p**s)} where p ++ is the characteristic. add - primeFrobenius(a) == a ** characteristic() - primeFrobenius(a,s) == a ** (characteristic()**s) + primeFrobenius(a) == a ** characteristic$% + primeFrobenius(a,s) == a ** (characteristic$%**s) @ \section{category XF ExtensionField} @@ -379,7 +379,7 @@ FiniteAlgebraicExtensionField(F : Field) : Category == _ error "trace: second argument must divide degree of extension" size() == size()$F ** extensionDegree() createNormalElement() == - characteristic() = size() => 1 + characteristic$% = size() => 1 res : $ for i in 1.. repeat res := index(i :: PI) @@ -595,15 +595,15 @@ FiniteFieldCategory() : Category ==_ l:=nullSpace mat empty? l or every?(zero?, first l) => "failed" map(charthRoot,first l) - charthRoot(x:$):$ == x**(size() quo characteristic()) + charthRoot(x:$):$ == x**(size()$% quo characteristic$%) charthRoot(x:%):Union($,"failed") == (charthRoot(x)@$)::Union($,"failed") createPrimitiveElement() == - sm1 : PositiveInteger := (size()$$-1) pretend PositiveInteger + sm1 : PositiveInteger := (size()$%-1) pretend PositiveInteger start : Integer := -- in the polynomial case, index from 1 to characteristic-1 -- gives prime field elements - representationType = "polynomial" => characteristic()::Integer + representationType = "polynomial" => characteristic$% 1 found : Boolean := false e : $ @@ -615,15 +615,14 @@ FiniteFieldCategory() : Category ==_ -- add special implementation for prime field case zero?(a) => false explist := factorsOfCyclicGroupSize() - q:=(size()-1)@Integer + q:=(size()$%-1)@Integer equalone : Boolean := false for exp in explist while not equalone repeat equalone := one?(a**(q quo exp.factor)) not equalone order(e: %): PositiveInteger == e = 0 => error "order(0) is not defined " - ord:Integer:= size()-1 -- order e divides ord - a:Integer:= 0 + ord:Integer:= size()$%-1 -- order e divides ord lof:=factorsOfCyclicGroupSize() for rec in lof repeat -- run through prime divisors a := ord quo (primeDivisor := rec.factor) @@ -649,7 +648,7 @@ FiniteFieldCategory() : Category ==_ b = gen => 1 disclog:Integer:=0 mult:Integer:=1 - groupord := (size() - 1)@Integer + groupord := (size()$% - 1)@Integer exp:Integer:=groupord for f in faclist repeat fac:=f.factor diff --git a/src/algebra/ffcg.spad.pamphlet b/src/algebra/ffcg.spad.pamphlet index 1ed736db..b1ff6b98 100644 --- a/src/algebra/ffcg.spad.pamphlet +++ b/src/algebra/ffcg.spad.pamphlet @@ -264,7 +264,7 @@ FiniteFieldCyclicGroupExtensionByPolynomial(GF,defpol):_ - x:$ == zero? x => 0 - characteristic() =$I 2 => x + characteristic$% =$I 2 => x addmod(x,shift(sizeCG,-1)$SI pretend Rep,sizeCG) generator() == 1$SI @@ -287,7 +287,7 @@ FiniteFieldCyclicGroupExtensionByPolynomial(GF,defpol):_ extensionDegree(): PositiveInteger == extdeg pretend PI - characteristic() == characteristic()$GF + characteristic == characteristic$GF lookup(x:$) == x =$Rep (-$Rep 1$Rep) => sizeFF pretend PI diff --git a/src/algebra/fff.spad.pamphlet b/src/algebra/fff.spad.pamphlet index 3eb3d683..b73ecc98 100644 --- a/src/algebra/fff.spad.pamphlet +++ b/src/algebra/fff.spad.pamphlet @@ -112,7 +112,7 @@ FiniteFieldFunctions(GF): Exports == Implementation where createLowComplexityTable(n) == q:=size()$GF -- this algorithm works only for prime fields - p:=characteristic()$GF + p:=characteristic$GF -- search of a suitable parameter k k:NNI:=0 a:NNI @@ -240,7 +240,7 @@ FiniteFieldFunctions(GF): Exports == Implementation where helparr.(lookup(a -$SAE(GF,SUP,f) 1$SAE(GF,SUP,f)_ )$SAE(GF,SUP,f)):=i::SI a:=a * primElement - characteristic() = 2 => + characteristic$GF = 2 => a:=primElement for i in 1..(qm1 quo 2) repeat zechlog.i:=helparr.lookup(a)$SAE(GF,SUP,f) diff --git a/src/algebra/ffnb.spad.pamphlet b/src/algebra/ffnb.spad.pamphlet index a4441b5a..8b9c7fbd 100644 --- a/src/algebra/ffnb.spad.pamphlet +++ b/src/algebra/ffnb.spad.pamphlet @@ -665,7 +665,7 @@ divisor of the order of the multiplicative group" erg:=concat(erg,v)$Rep erg - characteristic() == characteristic()$GF + characteristic == characteristic$GF random() == random(extdeg)$INBFF diff --git a/src/algebra/ffp.spad.pamphlet b/src/algebra/ffp.spad.pamphlet index c5832f93..02ed358e 100644 --- a/src/algebra/ffp.spad.pamphlet +++ b/src/algebra/ffp.spad.pamphlet @@ -261,7 +261,7 @@ FiniteFieldExtensionByPolynomial(GF:FiniteFieldCategory,_ retractIfCan(x) = "failed" => false true - characteristic() == characteristic()$GF + characteristic == characteristic$GF before?(x,y) == before?(x,y)$Rep @ diff --git a/src/algebra/ffpoly.spad.pamphlet b/src/algebra/ffpoly.spad.pamphlet index ee544ce5..b6f2f767 100644 --- a/src/algebra/ffpoly.spad.pamphlet +++ b/src/algebra/ffpoly.spad.pamphlet @@ -275,7 +275,7 @@ FiniteFieldPolynomialPackage GF : Exports == Implementation where -- qEulerPhiCyclotomic n == -- n = 1 => (sizeGF - 1) pretend PI --- p : PI := characteristic()$GF :: PI +-- p : PI := characteristic$GF :: PI -- (n rem p) = 0 => error -- "cyclotomic polynomial not defined for this argument value" -- q : PI := sizeGF @@ -332,7 +332,7 @@ FiniteFieldPolynomialPackage GF : Exports == Implementation where -- such that d divides q**k - 1 ([LN] p.65, Th. 2.47) n = 1 => (sizeGF - 1) :: NNI :: PI m : PI := n - p : PI := characteristic()$GF :: PI + p : PI := characteristic$GF :: PI q : PI := sizeGF while (m rem p) = 0 repeat -- find m such that m := (m quo p) :: PI -- n = m * p**r and gcd(m,p) = 1 diff --git a/src/algebra/ffx.spad.pamphlet b/src/algebra/ffx.spad.pamphlet index 4e45d712..06546d6b 100644 --- a/src/algebra/ffx.spad.pamphlet +++ b/src/algebra/ffx.spad.pamphlet @@ -36,7 +36,7 @@ IrredPolyOverFiniteField(GF:FiniteFieldCategory): Exports == Impl where getIrredPoly : (Z, N) -> SUP qAdicExpansion: Z -> SUP - p := characteristic()$GF :: N + p := characteristic$GF :: N q := size()$GF :: N qAdicExpansion(z : Z): SUP == diff --git a/src/algebra/fmod.spad.pamphlet b/src/algebra/fmod.spad.pamphlet index 47182caf..62b978fb 100644 --- a/src/algebra/fmod.spad.pamphlet +++ b/src/algebra/fmod.spad.pamphlet @@ -28,7 +28,7 @@ IntegerMod(p:PositiveInteger): Join(CommutativeRing, Finite, ConvertibleTo Integer, StepThrough) == add size() == p - characteristic() == p + characteristic == p lookup x == (zero? x => p; (convert(x)@Integer) :: PositiveInteger) -- Code is duplicated for the optimizer to kick in. diff --git a/src/algebra/fortmac.spad.pamphlet b/src/algebra/fortmac.spad.pamphlet index 07016a41..bc5d62b8 100644 --- a/src/algebra/fortmac.spad.pamphlet +++ b/src/algebra/fortmac.spad.pamphlet @@ -361,7 +361,7 @@ MachineFloat(): Exports == Implementation where sign(m1) = 0 and sign(m2) = -1 => false true - characteristic():NNI == 0 + characteristic:NNI == 0 @ \section{domain MCMPLX MachineComplex} diff --git a/src/algebra/fr.spad.pamphlet b/src/algebra/fr.spad.pamphlet index 082ff876..ebab36e4 100644 --- a/src/algebra/fr.spad.pamphlet +++ b/src/algebra/fr.spad.pamphlet @@ -218,7 +218,7 @@ Factored(R: IntegralDomain): Exports == Implementation where one? u == empty? u.fct and u.unt = 1 mkFF(r, x) == [r, x] coerce(j:Integer):% == (j::R)::% - characteristic() == characteristic()$R + characteristic == characteristic$R i:Integer * u:% == (i :: %) * u r:R * u:% == (r :: %) * u factors u == [[fe.fctr, fe.xpnt] for fe in factorList u] diff --git a/src/algebra/fraction.spad.pamphlet b/src/algebra/fraction.spad.pamphlet index 604771b7..8e0ff164 100644 --- a/src/algebra/fraction.spad.pamphlet +++ b/src/algebra/fraction.spad.pamphlet @@ -105,7 +105,7 @@ LocalAlgebra(A: Algebra R, == Localize(A, R, S) add 1 == 1$A / 1$S x:% * y:% == (numer(x) * numer(y)) / (denom(x) * denom(y)) - characteristic() == characteristic()$A + characteristic == characteristic$A @ \section{category QFCAT QuotientFieldCategory} @@ -180,7 +180,7 @@ QuotientFieldCategory(S: IntegralDomain): Category == map(fn, x) == (fn numer x) / (fn denom x) reducedSystem(m:Matrix %):Matrix S == clearDenominator m - characteristic() == characteristic()$S + characteristic == characteristic$S differentiate(x:%, deriv:S -> S) == n := numer x @@ -560,7 +560,7 @@ Fraction(S: IntegralDomain): QuotientFieldCategory S with -- to find x = p-th root of n/d -- observe that xd is p-th root of n*d**(p-1) ans:=charthRoot(x.num * - (x.den)**(characteristic()$%-1)::NonNegativeInteger) + (x.den)**(characteristic$%-1)::NonNegativeInteger) ans case "failed" => "failed" ans / x.den clear: List % -> List S diff --git a/src/algebra/fspace.spad.pamphlet b/src/algebra/fspace.spad.pamphlet index 5618839b..2a25eb6e 100644 --- a/src/algebra/fspace.spad.pamphlet +++ b/src/algebra/fspace.spad.pamphlet @@ -610,7 +610,7 @@ FunctionSpace(R: SetCategory): Category == Definition where -- cannot use new()$Symbol because of possible re-instantiation gendiff := "%%0"::SY - characteristic() == characteristic()$R + characteristic == characteristic$R coerce(k:K):% == k::MP::% symsub(sy, i) == concat(string sy, convert(i)@String)::SY numerator x == numer(x)::% diff --git a/src/algebra/gaussian.spad.pamphlet b/src/algebra/gaussian.spad.pamphlet index 25836835..2e7bd479 100644 --- a/src/algebra/gaussian.spad.pamphlet +++ b/src/algebra/gaussian.spad.pamphlet @@ -132,7 +132,7 @@ ComplexCategory(R:CommutativeRing): Category == trace x == 2 * real x imaginary() == complex(0, 1) conjugate x == complex(real x, - imag x) - characteristic() == characteristic()$R + characteristic == characteristic$R map(fn, x) == complex(fn real x, fn imag x) x = y == real(x) = real(y) and imag(x) = imag(y) x + y == complex(real x + real y, imag x + imag y) diff --git a/src/algebra/gpol.spad.pamphlet b/src/algebra/gpol.spad.pamphlet index 52918474..4ef5c712 100644 --- a/src/algebra/gpol.spad.pamphlet +++ b/src/algebra/gpol.spad.pamphlet @@ -71,7 +71,7 @@ LaurentPolynomial(R, UP): Exports == Implementation where coerce(p:UP):% == mkgpol(0, p) reductum p == check0(order p, reductum poly p) n:Z * p:% == check0(order p, n * poly p) - characteristic() == characteristic()$R + characteristic == characteristic$R coerce(n:Z):% == n::R::% degree p == degree(poly p)::Z + order p monomial? p == monomial? poly p diff --git a/src/algebra/intclos.spad.pamphlet b/src/algebra/intclos.spad.pamphlet index 5e5a13a5..7507efae 100644 --- a/src/algebra/intclos.spad.pamphlet +++ b/src/algebra/intclos.spad.pamphlet @@ -322,7 +322,7 @@ FunctionFieldIntegralBasis(R,UP,F): Exports == Implementation where tfm := ((rb * tfm0 * transpose rb) exquo (rbden * rbden)) :: Mat integralBasis() == - n := rank()$F; p := characteristic()$F + n := rank()$F; p := characteristic$F (not zero? p) and (n >= p) => error "integralBasis: possible wild ramification" tfm := traceMatrix()$F; disc := determinant tfm @@ -330,7 +330,7 @@ FunctionFieldIntegralBasis(R,UP,F): Exports == Implementation where iIntegralBasis(tfm,disc,sing) localIntegralBasis prime == - n := rank()$F; p := characteristic()$F + n := rank()$F; p := characteristic$F (not zero? p) and (n >= p) => error "integralBasis: possible wild ramification" tfm := traceMatrix()$F; disc := determinant tfm @@ -428,7 +428,7 @@ WildFunctionFieldIntegralBasis(K,R,UP,F): Exports == Implementation where -- 'standardBasis' is the basis for F as a FramedAlgebra; -- usually this is [1,y,y**2,...,y**(n-1)] p2 := prime * prime; sae := SAE(K,R,prime) - p := characteristic()$F; q := size()$sae + p := characteristic$F; q := size()$sae lp := leastPower(q,n) rb := scalarMatrix(n,1); rbinv := scalarMatrix(n,1) -- rb = basis matrix of current order diff --git a/src/algebra/interval.as.pamphlet b/src/algebra/interval.as.pamphlet index 765d7327..5ef14120 100644 --- a/src/algebra/interval.as.pamphlet +++ b/src/algebra/interval.as.pamphlet @@ -261,7 +261,7 @@ Interval(R:FUNCAT): IntervalCategory(R) == add { coerce(u:%):OutputForm == bracket([coerce inf(u), coerce sup(u)]$List(OutputForm)); - characteristic():NonNegativeInteger == 0; + characteristic:NonNegativeInteger == 0; -- Explicit export from TranscendentalFunctionCategory diff --git a/src/algebra/interval.spad.pamphlet b/src/algebra/interval.spad.pamphlet index 04ae4cd9..a15715c9 100644 --- a/src/algebra/interval.spad.pamphlet +++ b/src/algebra/interval.spad.pamphlet @@ -242,7 +242,7 @@ Interval(R:Join(FloatingPointSystem,TranscendentalFunctionCategory)): IntervalCa coerce(u:%):OutputForm == bracket([coerce inf(u), coerce sup(u)]$List(OutputForm)) - characteristic():NonNegativeInteger == 0 + characteristic:NonNegativeInteger == 0 -- Explicit export from TranscendentalFunctionCategory diff --git a/src/algebra/laurent.spad.pamphlet b/src/algebra/laurent.spad.pamphlet index 23d39979..eba51897 100644 --- a/src/algebra/laurent.spad.pamphlet +++ b/src/algebra/laurent.spad.pamphlet @@ -370,7 +370,7 @@ UnivariateLaurentSeriesConstructor(Coef,UTS):_ (s = variable(x)) => differentiate x map(differentiate(#1,s),x) - differentiate(center x,s)*differentiate(x) - characteristic() == characteristic()$Coef + characteristic == characteristic$Coef if Coef has Field then diff --git a/src/algebra/matrix.spad.pamphlet b/src/algebra/matrix.spad.pamphlet index d2b603d8..4a63ccf5 100644 --- a/src/algebra/matrix.spad.pamphlet +++ b/src/algebra/matrix.spad.pamphlet @@ -404,7 +404,7 @@ SquareMatrix(ndim,R): Exports == Implementation where ONE := scalarMatrix 1 1 == ONE - characteristic() == characteristic()$R + characteristic == characteristic$R new c == per new(ndim,ndim,c)$Rep diff --git a/src/algebra/modring.spad.pamphlet b/src/algebra/modring.spad.pamphlet index e4303078..d347318d 100644 --- a/src/algebra/modring.spad.pamphlet +++ b/src/algebra/modring.spad.pamphlet @@ -62,7 +62,7 @@ ModularRing(R,Mod,reduction:(R,Mod) -> R, coerce(x):OutputForm == (x.val)::OutputForm reduce (a:R,m:Mod) == [reduction(a,m),m]$Rep - characteristic():NonNegativeInteger == characteristic()$R + characteristic:NonNegativeInteger == characteristic$R 0 == [0$R,0$Mod]$Rep 1 == [1$R,0$Mod]$Rep zero? x == zero? x.val diff --git a/src/algebra/oct.spad.pamphlet b/src/algebra/oct.spad.pamphlet index b1ed406d..e2b6c52e 100644 --- a/src/algebra/oct.spad.pamphlet +++ b/src/algebra/oct.spad.pamphlet @@ -89,8 +89,8 @@ OctonionCategory(R: CommutativeRing): Category == inv : % -> % ++ inv(o) returns the inverse of o if it exists. add - characteristic() == - characteristic()$R + characteristic == + characteristic$R conjugate x == octon(real x, - imagi x, - imagj x, - imagk x, - imagE x,_ - imagI x, - imagJ x, - imagK x) diff --git a/src/algebra/opalg.spad.pamphlet b/src/algebra/opalg.spad.pamphlet index dc5b5e3f..19a4a9dc 100644 --- a/src/algebra/opalg.spad.pamphlet +++ b/src/algebra/opalg.spad.pamphlet @@ -87,7 +87,7 @@ ModuleOperator(R: Ring, M:LeftModule(R)): Exports == Implementation where elt(x:$, r:M) == +/[t.exp * termeval(t.gen, r) for t in terms x] rmeval(t, r) == t.coef * monomeval(t.monom, r) termcopy t == [[rm.coef, rm.monom] for rm in t] - characteristic() == characteristic()$R + characteristic == characteristic$R mkop(r, fg) == [[r, fg]$RM]$TERM :: $ evaluate(f, g) == nocopy setProperty(retract(f)@OP,OPEVAL,g pretend None) diff --git a/src/algebra/padic.spad.pamphlet b/src/algebra/padic.spad.pamphlet index e17fe7dc..5fc2275c 100644 --- a/src/algebra/padic.spad.pamphlet +++ b/src/algebra/padic.spad.pamphlet @@ -94,7 +94,7 @@ InnerPAdicInteger(p,unBalanced?): Exports == Implementation where Rep := ST I - characteristic() == 0 + characteristic == 0 euclideanSize(x) == order(x) stream(x:%):ST I == x pretend ST(I) diff --git a/src/algebra/perman.spad.pamphlet b/src/algebra/perman.spad.pamphlet index 2fa6e43d..f22aedd1 100644 --- a/src/algebra/perman.spad.pamphlet +++ b/src/algebra/perman.spad.pamphlet @@ -229,7 +229,7 @@ Permanent(n : PositiveInteger, R : Ring with commutative("*")): c : R := 0 sgn : R := 1 if (not (R has IntegralDomain)) - -- or (characteristic()$R = (2:NNI)) + -- or (characteristic$R = (2:NNI)) -- compiler refuses to compile the line above !! or (sgn + sgn = c) then return permanent3(x) diff --git a/src/algebra/pf.spad.pamphlet b/src/algebra/pf.spad.pamphlet index 611fbcff..38c956bb 100644 --- a/src/algebra/pf.spad.pamphlet +++ b/src/algebra/pf.spad.pamphlet @@ -103,7 +103,7 @@ InnerPrimeField(p:PositiveInteger): Exports == Implementation where createNormalElement() == 1 - characteristic() == p + characteristic == p factorsOfCyclicGroupSize() == p=2 => facOfGroupSize -- this fixes an infinite loop of functions diff --git a/src/algebra/pfr.spad.pamphlet b/src/algebra/pfr.spad.pamphlet index eeaa4c2f..21f36929 100644 --- a/src/algebra/pfr.spad.pamphlet +++ b/src/algebra/pfr.spad.pamphlet @@ -231,7 +231,7 @@ PartialFraction(R: EuclideanDomain): Cat == Capsule where 0 == [0$R, nil()$LfTerm] 1 == [1$R, nil()$LfTerm] - characteristic() == characteristic()$R + characteristic == characteristic$R coerce(r): % == [r, nil()$LfTerm] coerce(n): % == [(n :: R), nil()$LfTerm] diff --git a/src/algebra/poly.spad.pamphlet b/src/algebra/poly.spad.pamphlet index 077ba898..c71af1d9 100644 --- a/src/algebra/poly.spad.pamphlet +++ b/src/algebra/poly.spad.pamphlet @@ -438,11 +438,11 @@ SparseUnivariatePolynomial(R:Ring): UnivariatePolynomialCategory(R) with zero?(cc:=p.first.c ** n) => 0 [[n * p.first.k, cc]] -- not worth doing special trick if characteristic is too small - if characteristic()$R < 3 then return expt(p,n pretend PositiveInteger)$RepeatedSquaring(%) + if characteristic$R < 3 then return expt(p,n pretend PositiveInteger)$RepeatedSquaring(%) y:%:=1 -- break up exponent in qn * characteristic + rn -- exponentiating by the characteristic is fast - rec := divide(n, characteristic()$R) + rec := divide(n, characteristic$R) qn:= rec.quotient rn:= rec.remainder repeat @@ -450,8 +450,8 @@ SparseUnivariatePolynomial(R:Ring): UnivariatePolynomialCategory(R) with if rn > 1 then y:= y * binomThmExpt([p.first], p.rest, rn) zero? qn => return y -- raise to the characteristic power - p:= [[t.k * characteristic()$R , primeFrobenius(t.c)$R ]$Term for t in p] - rec := divide(qn, characteristic()$R) + p:= [[t.k * characteristic$R , primeFrobenius(t.c)$R ]$Term for t in p] + rec := divide(qn, characteristic$R) qn:= rec.quotient rn:= rec.remainder y diff --git a/src/algebra/polycat.spad.pamphlet b/src/algebra/polycat.spad.pamphlet index 60e29ed0..30d77de8 100644 --- a/src/algebra/polycat.spad.pamphlet +++ b/src/algebra/polycat.spad.pamphlet @@ -501,7 +501,7 @@ PolynomialCategory(R:Ring, E:OrderedAbelianMonoidSup, VarSet:OrderedSet): -- column, i.e. to one variable llR:List List R := [ empty() for z in first ll] monslist:List List % := empty() - ch:=characteristic()$% + ch:=characteristic$% for l in ll repeat mons:= "setUnion"/[primitiveMonomials u for u in l] redmons:List % :=[] @@ -530,7 +530,7 @@ PolynomialCategory(R:Ring, E:OrderedAbelianMonoidSup, VarSet:OrderedSet): ans := charthRoot ground p ans case "failed" => "failed" ans::R::% - ch:=characteristic()$% + ch:=characteristic$% charthRootlv(p,vars,ch) charthRootlv(p,vars,ch) == empty? vars => diff --git a/src/algebra/puiseux.spad.pamphlet b/src/algebra/puiseux.spad.pamphlet index 1bd402aa..ca2a82d7 100644 --- a/src/algebra/puiseux.spad.pamphlet +++ b/src/algebra/puiseux.spad.pamphlet @@ -298,7 +298,7 @@ UnivariatePuiseuxSeriesConstructor(Coef,ULS):_ map(fcn,upxs) == puiseux(getExpon upxs,map(fcn,getULS upxs)) - characteristic() == characteristic()$Coef + characteristic == characteristic$Coef -- multiplyCoefficients(f,upxs) == -- r := getExpon upxs diff --git a/src/algebra/quat.spad.pamphlet b/src/algebra/quat.spad.pamphlet index 709d9331..92ce1e47 100644 --- a/src/algebra/quat.spad.pamphlet +++ b/src/algebra/quat.spad.pamphlet @@ -76,8 +76,8 @@ QuaternionCategory(R: CommutativeRing): Category == add - characteristic() == - characteristic()$R + characteristic == + characteristic$R conjugate x == quatern(real x, - imagI x, - imagJ x, - imagK x) map(fn, x) == diff --git a/src/algebra/radix.spad.pamphlet b/src/algebra/radix.spad.pamphlet index f5ed227e..f67f6a68 100644 --- a/src/algebra/radix.spad.pamphlet +++ b/src/algebra/radix.spad.pamphlet @@ -91,7 +91,7 @@ RadixExpansion(bb): Exports == Implementation where checkRagits: List I -> Boolean -- Arithmetic operations - characteristic() == 0 + characteristic == 0 differentiate a == 0 0 == [1, nil(), nil(), nil()] diff --git a/src/algebra/reclos.spad.pamphlet b/src/algebra/reclos.spad.pamphlet index 3aa33230..23f67912 100644 --- a/src/algebra/reclos.spad.pamphlet +++ b/src/algebra/reclos.spad.pamphlet @@ -380,7 +380,7 @@ RealClosedField : Category == PUB where sqrt(a:Z):$ == sqrt(a::$,2) - characteristic() == 0 + characteristic == 0 rootOf(pol,n,o) == r := rootOf(pol,n) diff --git a/src/algebra/resring.spad.pamphlet b/src/algebra/resring.spad.pamphlet index 5137df07..343c34ca 100644 --- a/src/algebra/resring.spad.pamphlet +++ b/src/algebra/resring.spad.pamphlet @@ -60,7 +60,7 @@ ResidueRing(F,Expon,VarSet,FPol,LFPol) : Dom == Body (n : Integer) * x == n *$Rep x (a : F) * x == a *$Rep x x = y == x =$Rep y - characteristic() == characteristic()$F + characteristic == characteristic$F coerce(x) : OutputForm == coerce(x)$Rep @ diff --git a/src/algebra/sf.spad.pamphlet b/src/algebra/sf.spad.pamphlet index b104b7f5..35c59b87 100644 --- a/src/algebra/sf.spad.pamphlet +++ b/src/algebra/sf.spad.pamphlet @@ -87,7 +87,7 @@ RealNumberSystem(): Category == ++ abs x returns the absolute value of x. add - characteristic() == 0 + characteristic == 0 fractionPart x == x - truncate x truncate x == (negative? x => -floor(-x); floor x) round x == (negative? x => truncate(x-1/2::%); truncate(x+1/2::%)) diff --git a/src/algebra/si.spad.pamphlet b/src/algebra/si.spad.pamphlet index f620c59f..605f78e5 100644 --- a/src/algebra/si.spad.pamphlet +++ b/src/algebra/si.spad.pamphlet @@ -81,7 +81,7 @@ IntegerNumberSystem(): Category == -- commutative("*") -- follows from the above add - characteristic() == 0 + characteristic == 0 differentiate x == 0 even? x == not odd? x positive? x == x > 0 diff --git a/src/algebra/solvefor.spad.pamphlet b/src/algebra/solvefor.spad.pamphlet index faf51c7d..b82f1f35 100644 --- a/src/algebra/solvefor.spad.pamphlet +++ b/src/algebra/solvefor.spad.pamphlet @@ -135,7 +135,7 @@ PolynomialSolveByFormulas(UP, F): PSFcat == PSFdef where error "Leading coefficient must not be 0." needChar0(): Boolean == - characteristic()$F = 0 => true + characteristic$F = 0 => true error "Formula defined only for fields of characteristic 0." linear u == diff --git a/src/algebra/strap/CHAR.lsp b/src/algebra/strap/CHAR.lsp index f16acad3..6e24716c 100644 --- a/src/algebra/strap/CHAR.lsp +++ b/src/algebra/strap/CHAR.lsp @@ -100,8 +100,8 @@ (RETURN (CODE-CHAR (PROG1 (LETT #0# (- |n| 1) |CHAR;index;Pi$;4|) - (|check-subtype| (COND ((< #0# 0) 'NIL) ('T 'T)) - '(|NonNegativeInteger|) #0#)))))) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) + #0#)))))) (DEFUN |CHAR;lookup;$Pi;5| (|c| $) (PROG (#0=#:G1404) diff --git a/src/algebra/strap/DFLOAT.lsp b/src/algebra/strap/DFLOAT.lsp index f6af98ec..58577fe4 100644 --- a/src/algebra/strap/DFLOAT.lsp +++ b/src/algebra/strap/DFLOAT.lsp @@ -450,8 +450,7 @@ $) (|getShellEntry| $ 35))) |DFLOAT;bits;Pi;10|) - (|check-subtype| - (AND (COND ((< #0# 0) 'NIL) ('T 'T)) (< 0 #0#)) + (|check-subtype| (AND (NOT (< #0# 0)) (< 0 #0#)) '(|PositiveInteger|) #0#))))))) (DEFUN |DFLOAT;max;$;11| ($) @@ -641,8 +640,8 @@ (|DFLOAT;rationalApproximation;$2NniF;84| |x| (PROG1 (LETT #0# (- (FLOAT-DIGITS 0.0) 1) |DFLOAT;retract;$F;77|) - (|check-subtype| (COND ((< #0# 0) 'NIL) ('T 'T)) - '(|NonNegativeInteger|) #0#)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) + #0#)) (FLOAT-RADIX 0.0) $)))) (DEFUN |DFLOAT;retractIfCan;$U;78| (|x| $) @@ -652,7 +651,7 @@ (|DFLOAT;rationalApproximation;$2NniF;84| |x| (PROG1 (LETT #0# (- (FLOAT-DIGITS 0.0) 1) |DFLOAT;retractIfCan;$U;78|) - (|check-subtype| (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (FLOAT-RADIX 0.0) $))))) @@ -737,9 +736,7 @@ (LETT #0# (- |ex|) |DFLOAT;rationalApproximation;$2NniF;84|) (|check-subtype| - (COND - ((< #0# 0) 'NIL) - ('T 'T)) + (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#))) |DFLOAT;rationalApproximation;$2NniF;84|) (EXIT @@ -834,9 +831,7 @@ (EXPT BASE (PROG1 |ex| (|check-subtype| - (COND - ((< |ex| 0) 'NIL) - ('T 'T)) + (NOT (< |ex| 0)) '(|NonNegativeInteger|) |ex|)))) (|getShellEntry| $ 142))))))) #1# (EXIT #1#))))) diff --git a/src/algebra/strap/FFIELDC-.lsp b/src/algebra/strap/FFIELDC-.lsp index f29249fc..c9d9c3e1 100644 --- a/src/algebra/strap/FFIELDC-.lsp +++ b/src/algebra/strap/FFIELDC-.lsp @@ -82,7 +82,10 @@ (|getShellEntry| $ 34)))))))) (DEFUN |FFIELDC-;charthRoot;2S;6| (|x| $) - (SPADCALL |x| (QUOTIENT2 2 0) (|getShellEntry| $ 43))) + (SPADCALL |x| + (QUOTIENT2 (SPADCALL (|getShellEntry| $ 40)) + (|spadConstant| $ 41)) + (|getShellEntry| $ 43))) (DEFUN |FFIELDC-;charthRoot;SU;7| (|x| $) (CONS 0 (SPADCALL |x| (|getShellEntry| $ 32)))) @@ -90,13 +93,13 @@ (DEFUN |FFIELDC-;createPrimitiveElement;S;8| ($) (PROG (|sm1| |start| |i| |e| |found|) (RETURN - (SEQ (LETT |sm1| (- (SPADCALL (|getShellEntry| $ 46)) 1) + (SEQ (LETT |sm1| (- (SPADCALL (|getShellEntry| $ 40)) 1) |FFIELDC-;createPrimitiveElement;S;8|) (LETT |start| (COND - ((SPADCALL (SPADCALL (|getShellEntry| $ 49)) - (CONS 1 "polynomial") (|getShellEntry| $ 50)) - 0) + ((SPADCALL (SPADCALL (|getShellEntry| $ 48)) + (CONS 1 "polynomial") (|getShellEntry| $ 49)) + (|spadConstant| $ 41)) ('T 1)) |FFIELDC-;createPrimitiveElement;S;8|) (LETT |found| 'NIL |FFIELDC-;createPrimitiveElement;S;8|) @@ -107,9 +110,7 @@ (SPADCALL (PROG1 |i| (|check-subtype| - (AND - (COND ((< |i| 0) 'NIL) ('T 'T)) - (< 0 |i|)) + (AND (NOT (< |i| 0)) (< 0 |i|)) '(|PositiveInteger|) |i|)) (|getShellEntry| $ 14)) |FFIELDC-;createPrimitiveElement;S;8|) @@ -129,9 +130,10 @@ (SEQ (COND ((SPADCALL |a| (|getShellEntry| $ 16)) 'NIL) ('T - (SEQ (LETT |explist| (SPADCALL (|getShellEntry| $ 57)) + (SEQ (LETT |explist| (SPADCALL (|getShellEntry| $ 56)) + |FFIELDC-;primitive?;SB;9|) + (LETT |q| (- (SPADCALL (|getShellEntry| $ 40)) 1) |FFIELDC-;primitive?;SB;9|) - (LETT |q| (- 2 1) |FFIELDC-;primitive?;SB;9|) (LETT |equalone| 'NIL |FFIELDC-;primitive?;SB;9|) (SEQ (LETT |exp| NIL |FFIELDC-;primitive?;SB;9|) (LETT #0# |explist| |FFIELDC-;primitive?;SB;9|) @@ -148,8 +150,8 @@ (SPADCALL (SPADCALL |a| (QUOTIENT2 |q| (QCAR |exp|)) - (|getShellEntry| $ 59)) - (|getShellEntry| $ 60)) + (|getShellEntry| $ 58)) + (|getShellEntry| $ 59)) |FFIELDC-;primitive?;SB;9|))) (LETT #0# (CDR #0#) |FFIELDC-;primitive?;SB;9|) (GO G190) G191 (EXIT NIL)) @@ -161,12 +163,12 @@ (RETURN (SEQ (COND ((SPADCALL |e| (|spadConstant| $ 7) - (|getShellEntry| $ 64)) + (|getShellEntry| $ 63)) (|error| "order(0) is not defined ")) ('T - (SEQ (LETT |ord| (- 2 1) |FFIELDC-;order;SPi;10|) - (LETT |a| 0 |FFIELDC-;order;SPi;10|) - (LETT |lof| (SPADCALL (|getShellEntry| $ 57)) + (SEQ (LETT |ord| (- (SPADCALL (|getShellEntry| $ 40)) 1) + |FFIELDC-;order;SPi;10|) + (LETT |lof| (SPADCALL (|getShellEntry| $ 56)) |FFIELDC-;order;SPi;10|) (SEQ (LETT |rec| NIL |FFIELDC-;order;SPi;10|) (LETT #0# |lof| |FFIELDC-;order;SPi;10|) G190 @@ -185,8 +187,8 @@ (LETT |goon| (SPADCALL (SPADCALL |e| |a| - (|getShellEntry| $ 59)) - (|getShellEntry| $ 60)) + (|getShellEntry| $ 58)) + (|getShellEntry| $ 59)) |FFIELDC-;order;SPi;10|) (SEQ (LETT |j| 0 |FFIELDC-;order;SPi;10|) (LETT #1# (- (QCDR |rec|) 2) @@ -206,8 +208,8 @@ (LETT |goon| (SPADCALL (SPADCALL |e| |a| - (|getShellEntry| $ 59)) - (|getShellEntry| $ 60)) + (|getShellEntry| $ 58)) + (|getShellEntry| $ 59)) |FFIELDC-;order;SPi;10|))) (LETT |j| (QSADD1 |j|) |FFIELDC-;order;SPi;10|) @@ -229,20 +231,24 @@ ((SPADCALL |b| (|getShellEntry| $ 16)) (|error| "discreteLog: logarithm of zero")) ('T - (SEQ (LETT |faclist| (SPADCALL (|getShellEntry| $ 57)) + (SEQ (LETT |faclist| (SPADCALL (|getShellEntry| $ 56)) |FFIELDC-;discreteLog;SNni;11|) (LETT |a| |b| |FFIELDC-;discreteLog;SNni;11|) - (LETT |gen| (SPADCALL (|getShellEntry| $ 68)) + (LETT |gen| (SPADCALL (|getShellEntry| $ 67)) |FFIELDC-;discreteLog;SNni;11|) (EXIT (COND - ((SPADCALL |b| |gen| (|getShellEntry| $ 64)) + ((SPADCALL |b| |gen| (|getShellEntry| $ 63)) 1) ('T (SEQ (LETT |disclog| 0 |FFIELDC-;discreteLog;SNni;11|) (LETT |mult| 1 |FFIELDC-;discreteLog;SNni;11|) - (LETT |groupord| (- 2 1) + (LETT |groupord| + (- + (SPADCALL + (|getShellEntry| $ 40)) + 1) |FFIELDC-;discreteLog;SNni;11|) (LETT |exp| |groupord| |FFIELDC-;discreteLog;SNni;11|) @@ -277,15 +283,15 @@ |FFIELDC-;discreteLog;SNni;11|) (LETT |exptable| (SPADCALL |fac| - (|getShellEntry| $ 70)) + (|getShellEntry| $ 69)) |FFIELDC-;discreteLog;SNni;11|) (LETT |n| (SPADCALL |exptable| - (|getShellEntry| $ 71)) + (|getShellEntry| $ 70)) |FFIELDC-;discreteLog;SNni;11|) (LETT |c| (SPADCALL |a| |exp| - (|getShellEntry| $ 59)) + (|getShellEntry| $ 58)) |FFIELDC-;discreteLog;SNni;11|) (LETT |end| (QUOTIENT2 (- |fac| 1) |n|) @@ -309,7 +315,7 @@ (SPADCALL |c| (|getShellEntry| $ 11)) |exptable| - (|getShellEntry| $ 74)) + (|getShellEntry| $ 73)) |FFIELDC-;discreteLog;SNni;11|) (EXIT (COND @@ -333,9 +339,9 @@ |groupord| |fac|) (- |n|)) (|getShellEntry| $ - 59)) + 58)) (|getShellEntry| $ - 80)) + 79)) |FFIELDC-;discreteLog;SNni;11|))))) (LETT |i| (QSADD1 |i|) |FFIELDC-;discreteLog;SNni;11|) @@ -356,9 +362,9 @@ (SPADCALL |gen| (- |disc1|) (|getShellEntry| $ - 59)) + 58)) (|getShellEntry| $ - 80)) + 79)) |FFIELDC-;discreteLog;SNni;11|)))) ('T (|error| @@ -379,14 +385,14 @@ (SEQ (EXIT (COND ((SPADCALL |b| (|getShellEntry| $ 16)) (SEQ (SPADCALL "discreteLog: logarithm of zero" - (|getShellEntry| $ 86)) + (|getShellEntry| $ 85)) (EXIT (CONS 1 "failed")))) ((SPADCALL |logbase| (|getShellEntry| $ 16)) (SEQ (SPADCALL "discreteLog: logarithm to base zero" - (|getShellEntry| $ 86)) + (|getShellEntry| $ 85)) (EXIT (CONS 1 "failed")))) - ((SPADCALL |b| |logbase| (|getShellEntry| $ 64)) + ((SPADCALL |b| |logbase| (|getShellEntry| $ 63)) (CONS 0 1)) ('T (COND @@ -399,14 +405,14 @@ (|getShellEntry| $ 19))))) (SEQ (SPADCALL "discreteLog: second argument not in cyclic group generated by first argument" - (|getShellEntry| $ 86)) + (|getShellEntry| $ 85)) (EXIT (CONS 1 "failed")))) ('T (SEQ (LETT |faclist| (SPADCALL (SPADCALL |groupord| - (|getShellEntry| $ 90)) - (|getShellEntry| $ 92)) + (|getShellEntry| $ 89)) + (|getShellEntry| $ 91)) |FFIELDC-;discreteLog;2SU;12|) (LETT |a| |b| |FFIELDC-;discreteLog;2SU;12|) @@ -433,7 +439,7 @@ (LETT |primroot| (SPADCALL |logbase| (QUOTIENT2 |groupord| |fac|) - (|getShellEntry| $ 59)) + (|getShellEntry| $ 58)) |FFIELDC-;discreteLog;2SU;12|) (EXIT (SEQ @@ -452,9 +458,9 @@ (LETT |rhoHelp| (SPADCALL |primroot| (SPADCALL |a| |exp| - (|getShellEntry| $ 59)) + (|getShellEntry| $ 58)) |fac| - (|getShellEntry| $ 94)) + (|getShellEntry| $ 93)) |FFIELDC-;discreteLog;2SU;12|) (EXIT (COND @@ -482,8 +488,8 @@ (SPADCALL |logbase| (- |rho|) (|getShellEntry| $ - 59)) - (|getShellEntry| $ 80)) + 58)) + (|getShellEntry| $ 79)) |FFIELDC-;discreteLog;2SU;12|))))))) (LETT |t| (QSADD1 |t|) |FFIELDC-;discreteLog;2SU;12|) @@ -495,25 +501,25 @@ #2# (EXIT #2#))))) (DEFUN |FFIELDC-;squareFreePolynomial| (|f| $) - (SPADCALL |f| (|getShellEntry| $ 99))) + (SPADCALL |f| (|getShellEntry| $ 98))) (DEFUN |FFIELDC-;factorPolynomial| (|f| $) - (SPADCALL |f| (|getShellEntry| $ 101))) + (SPADCALL |f| (|getShellEntry| $ 100))) (DEFUN |FFIELDC-;factorSquareFreePolynomial| (|f| $) (PROG (|flist| |u| #0=#:G1521 #1=#:G1510 #2=#:G1508 #3=#:G1509) (RETURN (SEQ (COND - ((SPADCALL |f| (|spadConstant| $ 102) - (|getShellEntry| $ 103)) - (|spadConstant| $ 104)) + ((SPADCALL |f| (|spadConstant| $ 101) + (|getShellEntry| $ 102)) + (|spadConstant| $ 103)) ('T (SEQ (LETT |flist| - (SPADCALL |f| 'T (|getShellEntry| $ 108)) + (SPADCALL |f| 'T (|getShellEntry| $ 107)) |FFIELDC-;factorSquareFreePolynomial|) (EXIT (SPADCALL (SPADCALL (QCAR |flist|) - (|getShellEntry| $ 109)) + (|getShellEntry| $ 108)) (PROGN (LETT #3# NIL |FFIELDC-;factorSquareFreePolynomial|) @@ -535,13 +541,13 @@ (LETT #1# (SPADCALL (QCAR |u|) (QCDR |u|) - (|getShellEntry| $ 110)) + (|getShellEntry| $ 109)) |FFIELDC-;factorSquareFreePolynomial|) (COND (#3# (LETT #2# (SPADCALL #2# #1# - (|getShellEntry| $ 111)) + (|getShellEntry| $ 110)) |FFIELDC-;factorSquareFreePolynomial|)) ('T (PROGN @@ -554,11 +560,11 @@ (GO G190) G191 (EXIT NIL)) (COND (#3# #2#) - ('T (|spadConstant| $ 112)))) - (|getShellEntry| $ 113)))))))))) + ('T (|spadConstant| $ 111)))) + (|getShellEntry| $ 112)))))))))) (DEFUN |FFIELDC-;gcdPolynomial;3Sup;16| (|f| |g| $) - (SPADCALL |f| |g| (|getShellEntry| $ 115))) + (SPADCALL |f| |g| (|getShellEntry| $ 114))) (DEFUN |FiniteFieldCategory&| (|#1|) (PROG (|dv$1| |dv$| $ |pv$|) @@ -566,7 +572,7 @@ (PROGN (LETT |dv$1| (|devaluate| |#1|) . #0=(|FiniteFieldCategory&|)) (LETT |dv$| (LIST '|FiniteFieldCategory&| |dv$1|) . #0#) - (LETT $ (|newShell| 118) . #0#) + (LETT $ (|newShell| 117) . #0#) (|setShellEntry| $ 0 |dv$|) (|setShellEntry| $ 3 (LETT |pv$| (|buildPredVector| 0 0 NIL) . #0#)) @@ -590,72 +596,71 @@ (|NonNegativeInteger|) (71 . |size|) (75 . |characteristic|) (79 . |quo|) (85 . **) |FFIELDC-;charthRoot;2S;6| |FFIELDC-;charthRoot;SU;7| - (91 . |size|) (95 . -) + (91 . -) (|Union| '"prime" '"polynomial" '"normal" '"cyclic") - (101 . |representationType|) (105 . =) (111 . |false|) - (115 . |not|) (120 . =) + (97 . |representationType|) (101 . =) (107 . |false|) + (111 . |not|) (116 . =) |FFIELDC-;createPrimitiveElement;S;8| (|Record| (|:| |factor| 20) (|:| |exponent| 20)) - (|List| 55) (126 . |factorsOfCyclicGroupSize|) - (130 . |quo|) (136 . **) (142 . |one?|) - |FFIELDC-;primitive?;SB;9| (147 . |Zero|) (151 . |Zero|) - (155 . =) (|SingleInteger|) (161 . |Zero|) - |FFIELDC-;order;SPi;10| (165 . |primitiveElement|) - (|Table| 10 39) (169 . |tableForDiscreteLogarithm|) - (174 . |#|) (179 . |One|) (|Union| 39 '"failed") - (183 . |search|) (189 . |true|) (193 . *) (199 . +) - (205 . *) (211 . -) (216 . *) (222 . +) + (|List| 54) (122 . |factorsOfCyclicGroupSize|) + (126 . |quo|) (132 . **) (138 . |one?|) + |FFIELDC-;primitive?;SB;9| (143 . |Zero|) (147 . |Zero|) + (151 . =) (|SingleInteger|) (157 . |Zero|) + |FFIELDC-;order;SPi;10| (161 . |primitiveElement|) + (|Table| 10 39) (165 . |tableForDiscreteLogarithm|) + (170 . |#|) (175 . |One|) (|Union| 39 '"failed") + (179 . |search|) (185 . |true|) (189 . *) (195 . +) + (201 . *) (207 . -) (212 . *) (218 . +) |FFIELDC-;discreteLog;SNni;11| (|Void|) (|String|) - (|OutputForm|) (228 . |messagePrint|) (233 . |rem|) - (239 . |zero?|) (|Factored| $) (244 . |factor|) - (|Factored| 20) (249 . |factors|) + (|OutputForm|) (224 . |messagePrint|) (229 . |rem|) + (235 . |zero?|) (|Factored| $) (240 . |factor|) + (|Factored| 20) (245 . |factors|) (|DiscreteLogarithmPackage| 6) - (254 . |shanksDiscLogAlgorithm|) + (250 . |shanksDiscLogAlgorithm|) |FFIELDC-;discreteLog;2SU;12| - (|SparseUnivariatePolynomial| 6) (|Factored| 96) - (|UnivariatePolynomialSquareFree| 6 96) - (261 . |squareFree|) (|DistinctDegreeFactorize| 6 96) - (266 . |factor|) (271 . |Zero|) (275 . =) (281 . |Zero|) - (|Record| (|:| |irr| 96) (|:| |pow| 20)) (|List| 105) - (|Record| (|:| |cont| 6) (|:| |factors| 106)) - (285 . |distdfact|) (291 . |coerce|) (296 . |primeFactor|) - (302 . *) (308 . |One|) (312 . *) (|EuclideanDomain&| 96) - (318 . |gcd|) (|SparseUnivariatePolynomial| $) + (|SparseUnivariatePolynomial| 6) (|Factored| 95) + (|UnivariatePolynomialSquareFree| 6 95) + (257 . |squareFree|) (|DistinctDegreeFactorize| 6 95) + (262 . |factor|) (267 . |Zero|) (271 . =) (277 . |Zero|) + (|Record| (|:| |irr| 95) (|:| |pow| 20)) (|List| 104) + (|Record| (|:| |cont| 6) (|:| |factors| 105)) + (281 . |distdfact|) (287 . |coerce|) (292 . |primeFactor|) + (298 . *) (304 . |One|) (308 . *) (|EuclideanDomain&| 95) + (314 . |gcd|) (|SparseUnivariatePolynomial| $) |FFIELDC-;gcdPolynomial;3Sup;16|) - '#(|primitive?| 324 |order| 329 |nextItem| 339 |init| 344 - |gcdPolynomial| 348 |discreteLog| 354 |differentiate| 365 - |createPrimitiveElement| 370 |conditionP| 374 |charthRoot| - 379) + '#(|primitive?| 320 |order| 325 |nextItem| 335 |init| 340 + |gcdPolynomial| 344 |discreteLog| 350 |differentiate| 361 + |createPrimitiveElement| 366 |conditionP| 370 |charthRoot| + 375) 'NIL (CONS (|makeByteWordVec2| 1 'NIL) (CONS '#() (CONS '#() - (|makeByteWordVec2| 117 + (|makeByteWordVec2| 116 '(0 6 0 7 1 6 10 0 11 0 10 0 12 2 10 0 0 0 13 1 6 0 10 14 1 6 15 0 16 1 6 10 0 19 1 21 0 20 22 1 26 25 0 27 1 25 15 0 28 1 25 24 0 29 2 24 15 30 0 31 - 1 6 0 0 32 2 24 0 33 0 34 0 15 39 40 - 0 20 39 41 2 39 0 0 0 42 2 6 0 0 39 - 43 0 6 39 46 2 20 0 0 0 47 0 6 48 49 - 2 48 15 0 0 50 0 15 0 51 1 15 0 0 52 - 2 10 15 0 0 53 0 6 56 57 2 20 0 0 0 - 58 2 6 0 0 20 59 1 6 15 0 60 0 39 0 - 62 0 20 0 63 2 6 15 0 0 64 0 65 0 66 - 0 6 0 68 1 6 69 20 70 1 69 39 0 71 0 - 39 0 72 2 69 73 10 0 74 0 15 0 75 2 - 39 0 39 0 76 2 39 0 0 0 77 2 20 0 20 - 0 78 1 20 0 0 79 2 6 0 0 0 80 2 20 0 - 0 0 81 1 85 83 84 86 2 39 0 0 0 87 1 - 39 15 0 88 1 20 89 0 90 1 91 56 0 92 - 3 93 73 6 6 39 94 1 98 97 96 99 1 100 - 97 96 101 0 96 0 102 2 96 15 0 0 103 - 0 97 0 104 2 100 107 96 15 108 1 96 0 - 6 109 2 97 0 96 20 110 2 97 0 0 0 111 - 0 97 0 112 2 97 0 96 0 113 2 114 0 0 - 0 115 1 0 15 0 61 1 0 10 0 67 1 0 21 - 0 23 1 0 17 0 18 0 0 0 9 2 0 116 116 - 116 117 1 0 39 0 82 2 0 73 0 0 95 1 0 - 0 0 8 0 0 0 54 1 0 36 37 38 1 0 0 0 - 44 1 0 17 0 45))))) + 1 6 0 0 32 2 24 0 33 0 34 0 6 39 40 0 + 6 39 41 2 39 0 0 0 42 2 6 0 0 39 43 2 + 20 0 0 0 46 0 6 47 48 2 47 15 0 0 49 + 0 15 0 50 1 15 0 0 51 2 10 15 0 0 52 + 0 6 55 56 2 20 0 0 0 57 2 6 0 0 20 58 + 1 6 15 0 59 0 39 0 61 0 20 0 62 2 6 + 15 0 0 63 0 64 0 65 0 6 0 67 1 6 68 + 20 69 1 68 39 0 70 0 39 0 71 2 68 72 + 10 0 73 0 15 0 74 2 39 0 39 0 75 2 39 + 0 0 0 76 2 20 0 20 0 77 1 20 0 0 78 2 + 6 0 0 0 79 2 20 0 0 0 80 1 84 82 83 + 85 2 39 0 0 0 86 1 39 15 0 87 1 20 88 + 0 89 1 90 55 0 91 3 92 72 6 6 39 93 1 + 97 96 95 98 1 99 96 95 100 0 95 0 101 + 2 95 15 0 0 102 0 96 0 103 2 99 106 + 95 15 107 1 95 0 6 108 2 96 0 95 20 + 109 2 96 0 0 0 110 0 96 0 111 2 96 0 + 95 0 112 2 113 0 0 0 114 1 0 15 0 60 + 1 0 10 0 66 1 0 21 0 23 1 0 17 0 18 0 + 0 0 9 2 0 115 115 115 116 1 0 39 0 81 + 2 0 72 0 0 94 1 0 0 0 8 0 0 0 53 1 0 + 36 37 38 1 0 0 0 44 1 0 17 0 45))))) '|lookupComplete|)) diff --git a/src/algebra/strap/FPS-.lsp b/src/algebra/strap/FPS-.lsp index c85e10be..20b4f76e 100644 --- a/src/algebra/strap/FPS-.lsp +++ b/src/algebra/strap/FPS-.lsp @@ -22,8 +22,7 @@ (|getShellEntry| $ 16)) 13301)) |FPS-;digits;Pi;2|) - (|check-subtype| - (AND (COND ((< #0# 0) 'NIL) ('T 'T)) (< 0 #0#)) + (|check-subtype| (AND (NOT (< #0# 0)) (< 0 #0#)) '(|PositiveInteger|) #0#))))) (DEFUN |FloatingPointSystem&| (|#1|) diff --git a/src/algebra/strap/ILIST.lsp b/src/algebra/strap/ILIST.lsp index 5f67bbd8..ee920771 100644 --- a/src/algebra/strap/ILIST.lsp +++ b/src/algebra/strap/ILIST.lsp @@ -437,8 +437,7 @@ (|ILIST;rest;$Nni$;19| |p| (PROG1 (LETT #0# (- |n| 1) |ILIST;split!;$I$;29|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) $) |ILIST;split!;$I$;29|) @@ -460,8 +459,7 @@ (SEQ (LETT |l| (PROG1 (LETT #0# (QUOTIENT2 |n| 2) |ILIST;mergeSort|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) |ILIST;mergeSort|) (LETT |q| (|ILIST;split!;$I$;29| |p| |l| $) diff --git a/src/algebra/strap/INS-.lsp b/src/algebra/strap/INS-.lsp index ff98f1df..20c9737a 100644 --- a/src/algebra/strap/INS-.lsp +++ b/src/algebra/strap/INS-.lsp @@ -128,13 +128,13 @@ ((SPADCALL |x| (|spadConstant| $ 10) (|getShellEntry| $ 16)) (PROG1 (LETT #0# (- (SPADCALL |x| (|getShellEntry| $ 29))) |INS-;euclideanSize;SNni;9|) - (|check-subtype| (COND ((< #0# 0) 'NIL) ('T 'T)) - '(|NonNegativeInteger|) #0#))) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) + #0#))) ('T (PROG1 (LETT #1# (SPADCALL |x| (|getShellEntry| $ 29)) |INS-;euclideanSize;SNni;9|) - (|check-subtype| (COND ((< #1# 0) 'NIL) ('T 'T)) - '(|NonNegativeInteger|) #1#))))))) + (|check-subtype| (NOT (< #1# 0)) '(|NonNegativeInteger|) + #1#))))))) (DEFUN |INS-;convert;SF;10| (|x| $) (SPADCALL (SPADCALL |x| (|getShellEntry| $ 29)) diff --git a/src/algebra/strap/ISTRING.lsp b/src/algebra/strap/ISTRING.lsp index 5698408d..f0cba6fe 100644 --- a/src/algebra/strap/ISTRING.lsp +++ b/src/algebra/strap/ISTRING.lsp @@ -206,7 +206,7 @@ (MAKE-FULL-CVEC (PROG1 (LETT #0# (+ (- |m| (+ (- |h| |l|) 1)) |n|) |ISTRING;replace;$Us2$;15|) - (|check-subtype| (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (SPADCALL (|getShellEntry| $ 52))) |ISTRING;replace;$Us2$;15|) @@ -750,8 +750,7 @@ |ISTRING;match?;2$CB;34|) $) |ISTRING;match?;2$CB;34|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) |ISTRING;match?;2$CB;34|) (EXIT (COND @@ -781,10 +780,7 @@ |dontcare| |pattern| (+ |p| 1) $) |ISTRING;match?;2$CB;34|) - (|check-subtype| - (COND - ((< #1# 0) 'NIL) - ('T 'T)) + (|check-subtype| (NOT (< #1# 0)) '(|NonNegativeInteger|) #1#)) |ISTRING;match?;2$CB;34|) (SEQ G190 @@ -807,9 +803,7 @@ |s| |target| |i| $) |ISTRING;match?;2$CB;34|) (|check-subtype| - (COND - ((< #2# 0) 'NIL) - ('T 'T)) + (NOT (< #2# 0)) '(|NonNegativeInteger|) #2#)) |ISTRING;match?;2$CB;34|) (EXIT @@ -835,9 +829,7 @@ (+ |q| 1) $) |ISTRING;match?;2$CB;34|) (|check-subtype| - (COND - ((< #4# 0) 'NIL) - ('T 'T)) + (NOT (< #4# 0)) '(|NonNegativeInteger|) #4#)) |ISTRING;match?;2$CB;34|))))))) diff --git a/src/algebra/strap/LSAGG-.lsp b/src/algebra/strap/LSAGG-.lsp index 09fe53fb..72f15b22 100644 --- a/src/algebra/strap/LSAGG-.lsp +++ b/src/algebra/strap/LSAGG-.lsp @@ -252,8 +252,7 @@ (PROG1 (LETT #0# (- (- |i| 1) |m|) |LSAGG-;insert!;SAIA;7|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 39)) |LSAGG-;insert!;SAIA;7|) @@ -280,8 +279,7 @@ (PROG1 (LETT #0# (- (- |i| 1) |m|) |LSAGG-;insert!;2AIA;8|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 39)) |LSAGG-;insert!;2AIA;8|) @@ -360,8 +358,7 @@ (PROG1 (LETT #0# (- (- |i| 1) |m|) |LSAGG-;delete!;AIA;10|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 39)) |LSAGG-;delete!;AIA;10|) @@ -395,9 +392,7 @@ (LETT #0# (- (+ |h| 1) |m|) |LSAGG-;delete!;AUsA;11|) (|check-subtype| - (COND - ((< #0# 0) 'NIL) - ('T 'T)) + (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 39))) ('T @@ -407,9 +402,7 @@ (LETT #1# (- (- |l| 1) |m|) |LSAGG-;delete!;AUsA;11|) (|check-subtype| - (COND - ((< #1# 0) 'NIL) - ('T 'T)) + (NOT (< #1# 0)) '(|NonNegativeInteger|) #1#)) (|getShellEntry| $ 39)) @@ -420,9 +413,7 @@ (LETT #2# (+ (- |h| |l|) 2) |LSAGG-;delete!;AUsA;11|) (|check-subtype| - (COND - ((< #2# 0) 'NIL) - ('T 'T)) + (NOT (< #2# 0)) '(|NonNegativeInteger|) #2#)) (|getShellEntry| $ 39)) @@ -490,8 +481,7 @@ (SEQ (LETT |l| (PROG1 (LETT #0# (QUOTIENT2 |n| 2) |LSAGG-;mergeSort|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) |LSAGG-;mergeSort|) (LETT |q| @@ -700,8 +690,7 @@ (PROG1 (LETT #0# (- |s| |m|) |LSAGG-;copyInto!;2AIA;22|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 39)) |LSAGG-;copyInto!;2AIA;22|) @@ -745,8 +734,7 @@ (PROG1 (LETT #0# (- |s| |m|) |LSAGG-;position;SA2I;23|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 39)) |LSAGG-;position;SA2I;23|) diff --git a/src/algebra/strap/STAGG-.lsp b/src/algebra/strap/STAGG-.lsp index 53a1ca39..d461af4c 100644 --- a/src/algebra/strap/STAGG-.lsp +++ b/src/algebra/strap/STAGG-.lsp @@ -86,8 +86,7 @@ (LETT |x| (SPADCALL |x| (PROG1 |i| - (|check-subtype| - (COND ((< |i| 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< |i| 0)) '(|NonNegativeInteger|) |i|)) (|getShellEntry| $ 28)) |STAGG-;elt;AIS;5|) @@ -108,8 +107,7 @@ (SPADCALL (SPADCALL |x| (PROG1 |l| - (|check-subtype| - (COND ((< |l| 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< |l| 0)) '(|NonNegativeInteger|) |l|)) (|getShellEntry| $ 28)) (|getShellEntry| $ 33))) @@ -126,18 +124,14 @@ (SPADCALL |x| (PROG1 |l| (|check-subtype| - (COND - ((< |l| 0) 'NIL) - ('T 'T)) + (NOT (< |l| 0)) '(|NonNegativeInteger|) |l|)) (|getShellEntry| $ 28)) (PROG1 (LETT #0# (+ (- |h| |l|) 1) |STAGG-;elt;AUsA;6|) (|check-subtype| - (COND - ((< #0# 0) 'NIL) - ('T 'T)) + (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 37))))))))))))) @@ -195,8 +189,7 @@ (LETT |x| (SPADCALL |x| (PROG1 |i| - (|check-subtype| - (COND ((< |i| 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< |i| 0)) '(|NonNegativeInteger|) |i|)) (|getShellEntry| $ 28)) |STAGG-;setelt;AI2S;11|) @@ -231,9 +224,7 @@ (SPADCALL |x| (PROG1 |l| (|check-subtype| - (COND - ((< |l| 0) 'NIL) - ('T 'T)) + (NOT (< |l| 0)) '(|NonNegativeInteger|) |l|)) (|getShellEntry| $ 28)) @@ -244,9 +235,7 @@ (LETT #0# (+ (- |h| |l|) 1) |STAGG-;setelt;AUs2S;12|) (|check-subtype| - (COND - ((< #0# 0) 'NIL) - ('T 'T)) + (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 28)) diff --git a/src/algebra/strap/URAGG-.lsp b/src/algebra/strap/URAGG-.lsp index 6679030e..5d4e9577 100644 --- a/src/algebra/strap/URAGG-.lsp +++ b/src/algebra/strap/URAGG-.lsp @@ -452,8 +452,7 @@ (SPADCALL |x| (PROG1 (LETT #0# (- |m| |n|) |URAGG-;last;ANniA;22|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 62)) (|getShellEntry| $ 63))))))))) @@ -590,8 +589,7 @@ (SPADCALL |p| (PROG1 (LETT #0# (- |n| 1) |URAGG-;split!;AIA;32|) - (|check-subtype| - (COND ((< #0# 0) 'NIL) ('T 'T)) + (|check-subtype| (NOT (< #0# 0)) '(|NonNegativeInteger|) #0#)) (|getShellEntry| $ 62)) |URAGG-;split!;AIA;32|) diff --git a/src/algebra/sups.spad.pamphlet b/src/algebra/sups.spad.pamphlet index 100d251e..80d3a02e 100644 --- a/src/algebra/sups.spad.pamphlet +++ b/src/algebra/sups.spad.pamphlet @@ -234,7 +234,7 @@ InnerSparseUnivariatePowerSeries(Coef): Exports == Implementation where --% values - characteristic() == characteristic()$Coef + characteristic == characteristic$Coef 0 == monomial(0,0) 1 == monomial(1,0) diff --git a/src/algebra/taylor.spad.pamphlet b/src/algebra/taylor.spad.pamphlet index 2005597a..a54ec020 100644 --- a/src/algebra/taylor.spad.pamphlet +++ b/src/algebra/taylor.spad.pamphlet @@ -126,7 +126,7 @@ InnerTaylorSeries(Coef): Exports == Implementation where n = 0 => 1 expt(x,n :: PositiveInteger)$RepeatedSquaring(%) - characteristic() == characteristic()$Coef + characteristic == characteristic$Coef pole? x == false iOrder: (ST,NNI,NNI) -> NNI diff --git a/src/algebra/vector.spad.pamphlet b/src/algebra/vector.spad.pamphlet index 1696e4e4..7342a113 100644 --- a/src/algebra/vector.spad.pamphlet +++ b/src/algebra/vector.spad.pamphlet @@ -274,7 +274,7 @@ DirectProductCategory(dim:NonNegativeInteger, R:Type): Category == equation2R: Vector % -> Matrix R coerce(n:Integer):% == n::R::% - characteristic() == characteristic()$R + characteristic == characteristic$R differentiate(z:%, d:R -> R) == map(d, z) equation2R v == diff --git a/src/algebra/xpoly.spad.pamphlet b/src/algebra/xpoly.spad.pamphlet index c80e3e53..ef221d08 100644 --- a/src/algebra/xpoly.spad.pamphlet +++ b/src/algebra/xpoly.spad.pamphlet @@ -1063,7 +1063,7 @@ XRecursivePolynomial(VarSet:OrderedSet,R:Ring): Xcat == Xdef where p case R => 0$% [0$R,p.reg]$VPOLY - characteristic == characteristic()$R + characteristic == characteristic$R recip p == p case R => recip(p::R) "failed" |