File pari.changes of Package pari
-------------------------------------------------------------------
Sat Oct 19 18:34:39 UTC 2024 - Anton Shvetz <shvetz.anton@gmail.com>
- Update to release 2.17.0
* Fixed
+ rare SEGV in sumnumrat [#2566]
+ gp -p N did not check for N < 2^32
+ nflist([6,8],12167) -> SEGV [#2567]
+ nflist([6,1],1229312), nflist([6,10],36192256) -> duplicate
fields
+ variable leak in algsplit
+ mfslashexpansion: possible extra rational factor [#2572]
+ nfeltsign: possible wrong result
* Added
+ [libpari] Flm_sqr
* Changed
+ qflll(,1), qfllgram(,1): disable FLATTER algorithm.
+ tunings of forprime over "short" intervals (use sieve more
frequently)
- Update to release 2.16.2
* Fixed
+ rare oo-loop in nfdisc [#2510]
+ polcoeff(polmodular(2, 0, ffgen([7,2])^0),0).mod -> incorrect
[#2533]
+ rnfconductor(...,[P, B]) -> wrong result [#2534]
+ vecsearch(t_LIST,) would raise a type error [#2535]
+ subcycloiwasawa(x^2+87,3) -> SEGV
+ forprimestep and variants with initial value negative [#2531]
+ when converting a t_QFB to a vector of given length, remove
discriminant
+ \o3 [tex2mail]: support \*
+ rnfpolredabs didn't always return a canonical model [#2538]
+ weber(I/2+1/3,2) -> SEGV
+ [mpi] setting datadir or path in .gprc caused crashes
+ imprecise sqrtnr [#2543]
+ idealstar(nf,id,,MOD). Need to store MOD in the structure,
otherwise exceptions may occur [#2549]
+ ellsaturation was leaking variable numbers
+ rnfelttrace(rnf, t_POL in rnf.pol variable): wrong [#2509]
+ rnfeltnorm(rnf, t_POL in rnf.pol variable): wrong [#2509]
+ b=9/10; hypergeom([b+2, b], 2*b, 2/3): wrong [#2551]
+ overflows not tested in subcycloiwasawa [#2552]
+ randomprime([1,2], Mod(1,2)) -> 3
+ b;a;gcd(Mod(1,a^2+1),Mod(1,b^2+Mod(-a,a^2+1))) -> wrong
result [#2553]
+ idealismaximal(nf, <some elt>) -> impossible inverse [#2556]
+ polynomial coefs which are exact 0 should not be printed
[#2558]
+ f = Mod(Mod(1,3), Mod(a^2+2,3))*x^3; (1/f) * O(x^2) -> O(x^0)
instead of Mod(Mod(0, 3), Mod(1, 3)*a^2 + Mod(2, 3))*x^-2 +
O(x^-1) [#2558]
+ hgmeulerfactor could return wrong result [#2557]
+ (Mod(0,2)+O(x)) * (1+O(x)) -> Mod(0, 2)*x + O(x^2) [#2559]
+ z = ffgen(11^5)^0; fflog(z, z, 1) ->SEGV [#2562]
* Changed
+ plotell renamed to plotarc
+ lfun for degree 1 L-functions: use Riemann-Siegel when
imag(s) is large
+ zetahurwitz, lerchzeta: use Tyagi's method when imag(s) is
large
+ forprimestep: allow modulus not fitting in an unsigned long
+ specify how Vec(v, n) truncates v when #v > |n|. Changes
previous behaviour when n < 0: Vec([1,2,3], -2) -> [2,3]
(was [1,2]) Same for Vecrev, Vecsmall, Col, and Colrev.
+ allow abs(+oo), abs(-oo)
+ [libpari] gp_embedded : make interface more similar to GP
+ [libpari] callback cb_pari_display_hist (used by gp_embedded)
+ [libpari] the diffptr low level interface is gone (table of
difference of primes), replaced by a table of 32bit primes
(pari_PRIMES). The byteptr type and following functions /
macros are gone: initprimes, init_primepointer_geq,
init_primepointer_gt, init_primepointer_leq,
init_primepointer_lt NEXT_PRIME_VIADIFF, PREC_PRIME_VIADIFF,
NEXT_PRIME_VIADIFF_CHECK.
+ bnfisintnorm: add flag to return solution in factored form
* Added
+ GP function mapapply
+ GP function qfcholesky
+ [libpari] pari_err_display, gp_display_hist, str_display_hist
+ allow vecmin and vecmax to handle t_LIST
+ support 'rnf' structure in nfnewprec
+ [libpari] rnfnewprec, rnfnewprec_shallow
+ [examples] gp_embedded.c, like minigp.c but using gp_embedded
+ new GP default 'factorlimit'
+ new GP function bnrstarkunit
+ [libpari] bid_get_MOD
+ [libpari] Z_to_famat, Q_to_famat
+ new GP function hyperellordinate
+ [libpari] closure_callgen0
+ new GP function qfcvp
+ new GP function ellmaninconstant
+ new GP function nfweilheight
+ [libpari] Qp_psi
+ [libpari] FlxqX_eval
+ [libpari] Qp_zetahurwitz
+ [libpari] PRIMES_search
+ psi: support for derivative and t_PADIC
+ [libpari] ZM2_sqr
+ [libpari] FpXQX_roots_mult
+ [libpari] ZXX_pvalrem, ZXV_pvalrem
+ [libpari] pari_breakloop
- Update to release 2.16.1
* Fixed
+ lfunan(lfunetaquo([12,1;13*12,1]),1) -> stack overflow
[#2457]
+ FpM_intersect could return a Flm [#2459]
+ ifactor_sign: ifac_isprime could be called on input with tiny
divisors
+ nfcompositum could return non-monic polynomials [#2461]
+ gammamellininvinit(vector(9,i,1)) -> SEGV
+ incorrect sanity check in rnfeltdown ("not in base field")
[#2464]
+ precision loss in gammamellininv [#2462]
+ [pthread] parselect could crash
+ rare infinite loop in ellsaturation
+ quadunitindex(8461,2)->1 instead of 3 [#2466]
+ chinese(Mod(1,3)*(x^2+x+2),Mod(1,5)*(x-1)) -> incorrect
leading term
+ lindep([0,x]) -> SEGV
+ [libpari] RgX_div_by_X_x: wrong variable number
+ incorrect results in bnrisprincipal if bitprecision too low
[#2474]
+ hyperellratpoints(2*x^3+x^2-x,1000) -> wrong result [#2475]
+ ellisogeny over a nf -> inconsistent variables error
+ w=3;quadgen(5) -> print x instead of w [#2477]
+ FpX_convol: wrong result for mixed degree
+ parsum was inefficient
+ mateigen(,1): eigenvalues were given as t_VEC or t_COL. Use
t_COL.
+ ellcard over small finite field: potential oo-loop [#2483]
+ ellisomat/nf could miss isogenies of degree dividing the
conductor
+ mfcoef(mftwist(f,D), ...) wrong result [#2484]
+ sumeulerrat / prodeulerrat: slow if s not an integer [#2433]
+ 'path' broken when initial or trailing ':'
+ snfrank([1],0) -> 1 [instead of 0].
+ snfrank(vector of polynomials, 0) -> error
+ division of t_POLs with compatible domains Mod(1,2)/(2*x+1)
-> Mod(1,2)
+ strjoin([1]) -> memory corruption
+ qfbclassno(684) -> oo loop [#2491]
+ gcd(x-1,(x-1)/x) -> 1/x
+ mftonew was wrong on oldspace -> remove mfbd layer
+ rnf.p did not work
+ expm1(tiny negative t_REAL) -> stack overflow [#2494]
+ expm1(huge t_REAL) -> junk [#2494]
+ hyperellratpoints(9*x^2,3) -> SEGV
+ lambertw for 2-adics (also fix documentation)
+ plotbox, plotrbox did not clip properly
+ ellheight for non-minimal curve over a number field -> wrong
result
+ for x >= 0, x^(a/b) was using (x^(1/b))^a instead of
x^q*x^(r/b), with a = qb + r.
+ hypergeom(t_POL parameters, z) -> type error [#2515]
+ polrootsreal(0E10*x + 0E10) -> SEGV [#2516]
+ memory leak when using member functions and ~ arguments.
[#2513]
+ idealstar(nf,id,,MOD).cyc was not reduced modulo MOD
+ changed qfbred to use standard normalization (same as
qfbredsl2)
* Changed
+ dirpowerssum: allow functions with t_VEC output
+ dirpowerssum: add optional flag 'both' [also in library mode]
+ [libpari] RgX_halfgcd now only return the matrix. Use
RgX_halfgcd_all
+ [libpari] ec_bmodel, ec_phi2 now take a variable number
+ ellisomat: when E/nf has CM by an quadratic order included in
nf, return the discriminant of the order instead of an error
[#2231]
+ ZX_compositum_disjoint: renamed to ZX_composedsum
+ allow t_INTMOD Mod(m,N) as a Conrey label for the character m
mod N
+ nfroots: return a t_COL instead of a t_VEC (same as other
'roots' fun)
+ qfbsolve: call qfbcornacchia when the argument is prime (and
disc < 0)
+ [libpari] rename qfb_apply_ZM -> qfb_ZM_apply, qf_apply_RgM
-> qf_RgM_apply, qf_apply_ZM -> qf_ZM_apply
+ rnfinit(nf, [T,lim]); try to fix maximal order if wrong
[#2494]
+ [libpari] change prec to be a number of bits, instead of lg
+ [libpari] suminf_bitprec, intnumromb_bitprec: use suminf,
intnumromb ellL1_bitprec, ellanalyticrank_bitprec: use ellL1,
ellanalyticrank
* Added
+ [libpari] nfeltembed_i
+ [libpari] Flx_extresultant_pre, FlxqX_resultant_pre
+ [libpari] gc_stoi, gc_utoi, gc_utoipos
+ [libpari] F2xX_shift
+ [libpari] Flx_Fl_mul_pre
+ [libpari] Flx_halfgcd_all, Flx_halfgcd_all_pre,
FpX_halfgcd_all, FlxqX_halfgcd_all, FlxqX_halfgcd_all_pre,
FpXQX_halfgcd_all, F2xqX_halfgcd_all, FFX_halfgcd_all,
RgX_halfgcd_all
+ [libpari] modRr_i
+ [libpari] random_Fq
+ [libpari] maxprimelim
+ [libpari] FlxqX_div_by_X_x, FlxqX_div_by_X_x_pre
+ [libpari] Fl_2gener_pre_i, Fp_2gener_i, Fl2_sqrt_pre,
Flxq_sqrt_pre
+ [libpari] Fq_elljissupersingular
+ [libpari] FpXQ_ellcard_supersingular,
Fq_ellcard_supersingular
+ [libpari] Fp_ellj_to_a4a6
+ [libpari] ec_half_deriv_2divpol
+ New GP functions polisclass, elliscm
+ [libpari] elljsupersingular_FpXQ
+ New GP function ellsupersingularj
+ [libpari] Flx_composedsum, FlxV_composedsum FpX_composedsum,
FpXV_composedsum FlxqX_composedsum
+ [libpari] Flx_convol, Flx_composedprod, FpX_composedprod
+ [libpari] RgV_F2v_extract_shallow
+ [libpari] Fp_double
+ [libpari] convenience function veclast
+ allow snfrank(D,0) for snfrank(D)
+ [libpari] dbg_fill_stack() [#2361]
+ allow erfc(t_SER)
+ allow hypergeom(N,D,t_PADIC)
+ n#: primorial of n
+ allow bernpol(k, a) [ = B_k(a) ]
+ allow Qfb(a*x^2+b*x+c) and Qfb([a,b0;b1,c])
+ New GP function parforstep
+ New GP function polfromroots
+ digits: support for negative bases but positive digits.
+ alginit: new flag value for lazy factorization
+ [libpari] F2xqXV_prod, F2xqV_roots_to_pol, FFV_roots_to_pol
+ [libpari] RgM_div
+ [libpari] ZV_max_expi, ZM_max_expi
+ [libpari] ZM_merge_factor
+ [libpari] RgM_Cholesky
+ [libpari] hash_keys_GEN
+ support kB or KB, MB, GB and TB as units for memory sizes
(2^10, 2^20, 2^30 and 2^40 bytes)
+ [libpari] lg2prec, prec2lg
+ New GP function ellisisom
+ allow qfsolve([Q,F]) where F factorization of disc(Q)
+ New GP function plotell
* Removed
+ [graphic] support for Qt4
- Update to release 2.16.0
* Fixed
+ ploth long help was misformatted
+ polredbest(y^4 - y^3 - 1/4, 1) -> Error [#2414]
+ mathnf over polynomial rings: wrong when rank not maximal
[#2415]
+ seralgdep(Ser([0,1,0,u]*Mod(1,(u^2+u+1)*Mod(1,2)),y),2,2) ->
SEGV
+ polroots(4*x^3+4*x^2+28*x+144) -> overflow [#2418]
+ conversion to float of t_QUAD with t_FRAC components [#2419]
+ bnfinit(x^3-810693844986180*x-30702939461011257135364,1).fu
-> wrong result or SEGV [#2420]
+ [1,2]*[3,4] -> strange error message about qfbcomp
+ obscure oo loop in solve when solution ~ 0 [#2412]
+ polcyclo(huge n, t_PADIC of positive valuation) -> overflow
+ charpoly over R or C was unstable [#2406]
+ polredbest: rare error "inconsistent concatenation" [#2423]
+ hypergeom([0,0],[1],2) -> SEGV [#2425]
+ fromdigitsu(v, B) actually computed fromdigitsu(v, |B|)
+ powers(t_INT, ...) was very slow
+ factor(prod(i=1,20,nextprime(2^i)), 131) would include 131
instead of stopping at 67
+ sumeulerrat(x^2/(1+x),2) -> FPE [#2433]
+ lambertw(10^1000) -> overflow [#2429]
+ rare infinite loop in idealtwoelt [#2437]
+ nfisisom(16*x^4+1,16*x^4+1) -> error [#2432]
+ forprimestep(p=a,b,q,) overflow when a > primelimit and q
large [#2439]
+ lfun([bnrinit(bnfinit(y^2+1),12),[[2,0],[6,0]]],2) -> error
+ lfunthetacost(polcyclo(43)): silent overflow
+ ellcard(ellinit([1,1]*ffgen([41,16])))-> impossible inverse
[#2441]
+ wrong result (missing content) in idealred(nf, [id, elt])
+ det(integer matrix) -> inconsistent exact division [#2445]
+ fft([],[]) -> SEGV, fft([1],[1]) -> SEGV
+ nfrootsof1(x^0) -> oo-loop
+ hgmalpha did not check its input
+ hyperellchangecurve([],[]) -> SEGV
+ hyperellchangecurve(x^0,[1,matid(2),0]) -> SEGV
+ rnfeltnorm(x,x) -> SEGV
+ polylogmult(1,[],-1) -> SEGV
+ ellheight(non-integral E) -> crash [#2448]
+ content(1,y) -> pol_1(y) instead of t_INT 1
+ s=taylor(1/((x-1)*(y-1)),x); taylor(s,y) -> invalid object
[#2452]
+ avoid crashing when sumnumsidi diverges (0 bits of accuracy)
[#2454]
* Changed
+ binomial(negative t_INT, t_INT): use Loeb's definition
+ normalize t_RFRAC so that leading coeff of denoimator is
"positive"; compare: 1/(1-x) and 1/(x-1)
+ t_SER: valser, evalvalser, setvalser need to be used instead
of valp, evalvalp, setvalp
+ mathess over R or C: use maximal pivot instead of first
non-zero
+ default 'parisize' is now 8M on both 32bit and 64bit
architectures
+ default 'realprecision' is now 38 on both 32bit and 64bit
architectures
+ default 'realbitprecision' is now 128 on both 32bit and 64bit
architectures
+ default 'primelimit' is now 2^20 [instead of 500000]
+ allow fromdigits(t_COL or t_VECSMALL, B)
+ [libpari] cgetalloc arguments swapped to mirror cgetg's
definition
+ simplified lfunabelianrelinit (absolute equation is now
optional)
+ quadclassnoF_fact and uquadclassnoF_fact now return
h(D)/h(d), like quadclassnoF.
* Added
+ new syntax for forvec loops
+ [GP] genus2igusa
+ printf numerical conversions: support complex numbers [#2431]
+ libpari vecsmall_counting_indexsort, vecsmall_counting_sort
vecsmall_counting_uniq
+ [riscv64] add riscv64 assembly kernel
+ lfuncreate([bnr, subg]): Dedekind zeta for the corresponding
Abelian extension.
* Removed
+ [GP] lfunabelianrelinit. Use lfunfinit([bnr, subgroup])
instead.
- Fix build on SLE
-------------------------------------------------------------------
Sun Apr 7 06:28:29 UTC 2024 - Jan Engelhardt <jengelh@inai.de>
- Update to release 2.15.5
* Fix a memory corruption when using `strjoin([1])`
- Explicitly buildrequire amsmath.sty to fix a build failure.
-------------------------------------------------------------------
Sun Jul 16 11:04:16 UTC 2023 - Dirk Müller <dmueller@suse.com>
- update to 2.15.4:
* lfunan(lfunetaquo([12,1;13*12,1]),1) -> stack overflow
* FpM_intersect could return a Flm
* 3- ifac_isprime could be called on input with tiny
divisors
* nfcompositum could return non-monic polynomials
* gammamellininvinit(vector(9,i,1)) -> SEGV
* incorrect sanity check in rnfeltdown ("not in base
field")
* precision loss in gammamellininv
* [pthread] parselect could crash
* rare infinite loop in ellsaturation
* quadunitindex(8461,2)->1 instead of 3
* chinese(Mod(1,3)*(x^2+x+2),Mod(1,5)*(x-1))->incorrect
leading term
* lindep([0,x]) -> SEGV
* [libpari] RgX_div_by_X_x: wrong variable number
* MS 14- hyperellratpoints(2*x^3+x^2-x,1000) -> wrong result
* ellisogeny over a nf -> inconsistent variables error
* w=3;quadgen(5) -> print x instead of w
* FpX_convol: wrong result for mixed degree
* 18- mateigen(,1): eigenvalues were given as t_VEC or
t_COL. Use t_COL.
* ellcard over small finite field: potential oo-loop
- add pari.keyring for source integrity validation
-------------------------------------------------------------------
Mon Apr 17 06:01:18 UTC 2023 - Anton Shvetz <shvetz.anton@gmail.com>
- Update to 2.15.3
* rare infinite loop in idealtwoelt
* nfisisom(16*x^4+1,16*x^4+1) -> error
* forprimestep(p=a,b,q,) overflow when a > primelimit
* lfun([bnrinit(bnfinit(y^2+1),12),[[2,0],[6,0]]],2) -> error
* lfunthetacost(polcyclo(43)): silent overflow
* ellcard(ellinit([1,1]*ffgen([41,16])))-> impossible inverse
* wrong result (missing content) in idealred(nf, [id, elt])
* det(integer matrix) -> inconsistent exact division
* fft([],[]) -> SEGV, fft([1],[1]) -> SEGV
* nfrootsof1(x^0) -> oo-loop
* hgmalpha did not check its input
* hyperellchangecurve([],[]) -> SEGV
* hyperellchangecurve(x^0,[1,matid(2),0]) -> SEGV
* rnfeltnorm(x,x) -> SEGV
* polylogmult(1,[],-1) -> SEGV
* ellheight(non-integral E) -> crash
* content(1,y) -> pol_1(y) instead of t_INT 1
* s=taylor(1/((x-1)*(y-1)),x); taylor(s,y) -> invalid object
* avoid crashing when sumnumsidi diverges (0 bits of accuracy)
-------------------------------------------------------------------
Thu Jan 5 08:17:22 UTC 2023 - Dirk Müller <dmueller@suse.com>
- update to 2.15.2:
Fixed
polredbest: rare error "inconsistent concatenation"
hypergeom([0,0],[1],2)
powers(t_INT, ...) was very slow
factor(prod(i=1,20,nextprime(2^i)), 131) would include 131
sumeulerrat(x^2/(1+x),2) -> FPE
lambertw(10^1000) -> overflow
-------------------------------------------------------------------
Fri Nov 18 17:44:42 UTC 2022 - Jan Engelhardt <jengelh@inai.de>
- Update to release 2.15.1
* Resolve SIGSEGV with seralgdep and bnfinit functions
* Resolve obscure oo loop in solve when solution ~ 0
-------------------------------------------------------------------
Thu Oct 27 13:41:40 UTC 2022 - Andrea Manzini <andrea.manzini@suse.com>
- Update to release 2.15.0
* The GP language:
* Notion of DebugLevel "domains" that allow to finely control
diagnostics.
* The syntax setdebug(dom, val) and default(def, val) are now
recognized in the GPRC file.
* Linear Algebra:
* qflll() now implements most LLL modes in fplll (fast, dpe and
heuristic), allowing large speedups. Directly and in the many
functions that use the LLL algorithm.
* New GP function snfrank(), a utility function returning
q-ranks from Smith Normal Forms
* Elementary Number Theory:
* New GP function: harmonic(), to compute generalized harmonic
numbers
* Reworked Euler numbers, analogously to Benoulli's: eulervec()
is now faster and caches computed values, and a new GP
function eulerreal() computes floating point approximations.
* Elliptic Curves: New module to compute the Mordell-Weil group
of rational elliptic curves
* See https://pari.math.u-bordeaux.fr/pub/pari/unix/pari-2.15.0.changelog
for details.
-------------------------------------------------------------------
Wed Apr 13 18:58:43 UTC 2022 - Anton Shvetz <shvetz.anton@gmail.com>
- Update to release 2.13.4
* For z=x+wy a t_QUAD, z.pol returned the modulus z.mod instead
of the t_POL x+'w*y
* allow eulerianpol(0) (= 1)
* allow polylog(0,x) (was broken when eulerianpol
was introduced)
* concat(t_LIST,t_LIST) was leaking memory
* missing type checks in ellchangepoint (led to a SIGSEGV)
* polsturm(-25*x^4+2*x^3+99*x^2-44*x-132,[-oo,-4])
returned garbage
* ellheight(E,,Q) led to a SIGSEGV
* besselj(80,66) led to an infinite loop
* lfun(1, 0.0) "normalizing a series with a 0 leading term"
* (0. + O(x) == 1) returned 'true'
* idealismaximal(nfinit(x),Mat(2)) -> 0
* O(29^(-1)) == 1 was FALSE (same for -1)
* Mod(0, 2*x^0) == 1 was FALSE (same for -1)
* [X11] resizing a window could keep traces
of previous drawing
* x->x+0x1 was not displayed correctly
* bnfinit(Q) was not using current precision
* polresultant(t_POL with t_RFRAC coefs,...) led to internal
errors
* znchardecompose(znstar(2,1),[],2) led to SIGSEGV
* missing roots in nfroots(t_POL,)
* factorpadic: ensure leading coefs are powers of p
* nfsnf returned wrong results
* rare SEGV occurred in nfdisc
* factor((Mod(1,2)*((t^2+1)*x^4+(t^4+1)*x^2+1)))
led to a division by 0
* minpoly(Mod(1/(x-(t+1))*Mod(1,2),(t+1)*x^2+t*x+1))
led to an error
* factor(Mod(1,2)*x^5+a*x^3) led to division by 0
* nfgrunwaldwang: fix infinite loop
* ti=thueinit(3*x^3 + 5*x^2 - 14*x + 54,1); thue(ti,1)
led to an error
* bnrclassfield led to incorrect result when fundamental
units are large
-------------------------------------------------------------------
Tue Nov 2 00:19:07 UTC 2021 - Anton Shvetz <shvetz.anton@gmail.com>
- Update to release 2.13.3. Fixed
[last column crossreferences current development release 2.14.0]
* zeta(-2 + O(x)) => division by 0 [F25]
* (-1)^(-1/2) -> I instead of -I [F56]
* GC error in ZX_Uspensky(, flag = 0) [F58]
* ellisomat(ell/nf not integral) -> oo-loop or wrong result [F59]
* (f(~v)=v[1]=1);(g(v) = f(~v)); my(V=[0]);g(V);V -> [1]
instead of [0] due to missing copy on write [#2304] [F60]
* hypergeom([1/12,1/12],2/3,3) -> wrong result [F61]
* overflow in mulu_interval(,ULONG_MAX) [#2309] [F62]
* ellE(1) -> domain error [#2312] [F63]
* log1p(-1 + 10^-10) -> oo time [F64]
* bernvec entries were wrong from B_{2*4064} on [#2311] [F65]
* plotrecthraw for multi-curves [F66]
* RgXn_powu(,,1) wrong result [#2314] [F67]
* erfc incorrect on negative imaginary axis [#2315] [F68]
* mfgalpoistype bug for dihedral types (when conductor at oo
is not stable under Galois) [#2293] [F69]
* [32bit] forfactored(n=223092868, 223092871, ) ->
SEGV [#2318] [F70]
* Fp_issquare(0, p) would return 0 [F71]
-------------------------------------------------------------------
Sun Oct 31 20:36:12 UTC 2021 - Anton Shvetz <shvetz.anton@gmail.com>
- Split '%make_build all docpdf' into separate executions due to
non-reproducible results during parallel build with varying
numbers of jobs. Thanks to Bernhard M. Wiedemann for reporting
the bug.
-------------------------------------------------------------------
Fri Oct 29 01:01:54 UTC 2021 - Anton Shvetz <shvetz.anton@gmail.com>
- Update to release 2.13.2. Fixed
[last column crossreferences current development release 2.14.0]
* rnfidealup(, non-integral ideal) -> division by 0 [F22]
* memory leak in ellheight [F23]
* memory leak in bnfinit [F24]
* nfeltdiv(nfinit(x^2+1), 0, 1+x/2) -> SEGV [#2277] [F26]
* znchargauss(g,chi,0) -> oo loop [F28]
* bnflog(bnr, ...) -> SEGV [F29]
* elliptic functions: incorrect reduction
of z/w1 mod [1,tau] => catastrophic cancellation [F30]
* powcx(x, t_COMPLEX with 0 imaginary part) -> crash [F31]
* nfsubfields(t_POL in other var than x,,1) -> SEGV [F32]
* extra terms in power t_SER substitutions [#2281] [F33]
* k=bnfinit(quadpoly(-2923,a));
bnrclassfield(k,3) -> SEGV [#2280] [F34]
* rnfdisc mishandled polynomials with denominators [#2284] [F35]
* elltamagawa(ellinit([-1456/243,93184/19683])) ->
wrong result [F36]
* mfsearch would sometimes miss the trivial form [F37]
* typo in allh [affects ECPP tunings] [F38]
* mfisetaquo(mffrometaquo([1,12;193,12])) -> 0 [F39]
* polroots(1.E-47*t^6+1.E-47*t^5+4.E-46*t^4) ->
bug in type [#2286] [F40]
* ceil(quadgen(5)) -> 1 instead of 0 [#2288] [F41]
* floor(Mod(0,3)*quadgen(5)) -> crash [F42]
* wrong ispower(t_RFRAC) and issquare(t_RFRAC, &z) [#2289] [F45]
* 1+O(x)==O(x) [F47]
* qfauto([[1,0;0,1],[0,0;1,0]]) -> SEGV [F49]
* bnfsunit(...)[4] (the S-regulator) did not correspond to
its definition in the documentation [ was using log(p)
instead of log(Norm P)) for P in S above p ] [F50]
* rnfdisc could return corrupted result [F51]
* concat(List([1])[1..0]) ->SEGV (instead of error) [#2299] [F53]
* List([1])[1..0]==List() -> 0 instead of 1 [F54]
- Build PDF documentation and place it into separate
pari-doc package. Move examples from pari-devel package
to pari-doc.
- Add %{_sysconfdir}/gprc to packaging.
- Remove patch pari-nodate.diff (replace with the sed one-liner
in the %prep section).
- Remove obsolete stuff from the spec file.
- Apply spec-cleaner.
-------------------------------------------------------------------
Sun Feb 7 21:15:14 UTC 2021 - Aaron Puchert <aaronpuchert@alice-dsl.net>
- Update to release 2.13.1. Fixes the following bugs:
* GC error in idealinv.
* qfminim inefficiency (initial bound from non-LLL-reduced matrix).
* mfshimura in weight 3/2 => infinite loop
* matsolve([1,1,1/2; 1,0,1/2; 2,1,0], [-1;1;-1]) -> SEGV.
* qfminim(Mat(1),,,2) -> precision error.
* subst(p, v, t_SER) very slow if p contains many variables.
* mfsymboleval for trivial path returned 0 instead of a vector
of 0s when f has multiple embeddings.
* 2^(1 + O(3^4)) -> type error.
* Zn_quad_roots(8,0,-1) to compute roots of x^2-1 mod 8 -> [4,[1,3]]
(1 or 3 mod 4) instead of the expected [2,[1]] (1 mod 2).
* tan(1+10^20*I) -> overflow (same for cotan and psi).
* Mod(2,3)^1000000000000000000001 -> Mod(-1,3).
* subst(O(y) + x, x, (1 - y + O(y^2))*x + O(x^2)) -> SEGV.
* (Mod(0,3) + x) + O(x^2) -> x + O(x^2) [now Mod(1,3)*x + O(x^2)].
* Precision too low for units in mfgaloisprojrep.
* Missing GC at the end of RgXn_inv.
* (-1)^(1/3) -> -1 instead of exp(log(-1)/3).
* mfeisenstein(k, trivial characters mod N > 1) was incorrect.
* Missing GC in qfsolve.
-------------------------------------------------------------------
Mon Oct 26 15:03:47 UTC 2020 - Jan Engelhardt <jengelh@inai.de>
- Update to release 2.13.0
* New libpari functions: perm_sqr, perm_powu, perm_orderu, quodif.
* Added asymptotically fast quadunit.
* Faster intnumgaussinit and change default number of points
to B/4, suitable when b - a ~ distance to the nearest pole.
* In libpari, perm_pow now takes a t_INT exponent, permorder
and perm_order return a t_INT.
* sizebyte(objects containing t_LIST): would assign size 3 to all lists
* permorder returned incorrect results for large orders
* cure SIGSEGV on [Map(Mat([0, 0])), [0, 0, 1]]
* cure SIGSEGV on zeta(I+2^(-64))
* cure infinite loop on p=[4,54];lfunmf(mfinit(p,0), mftraceform(p,0))
* printf("%5.2f",M) transposed M
* bnfinit instability at low accuracy. E.g., at \p38
P=x^7+22*x^6+184*x^5+764*x^4+2020*x^3+3792*x^2+5712*x+4;
bnfinit(P,1).no -> 4 times too large
* Accuracy problems in bnfisunit after bnfinit(P,1). E.g.,
P=x^7-22*x^6+169*x^5-568*x^4+1263*x^3-1506*x^2+2295*x+2;
setrand(1); K=bnfinit(P,1); U=bnfunits(K,idealprimedec(K,2));
bnfisunit(K,4*(x^2-18*x+85)/x^2*Mod(1,K.pol),U) -> error
- Update to release 2.12.1.
* New functions in GP: asympnumraw, bnrmap, bnfunits,
dirpowerssum, ellpadiclambdamu, eulerianpol, eulerfrac,
eulerpol, eulervec, fft, fftinv, halfgcd, lfundual, lfunshift,
matreduce, mfisetaquo, mscosets, msfarey, nfsubfieldscm,
nfsubfieldsmax, parforeach, parforprimestep, parplothexport,
permcycles, polylogmult, rootsof1, zetamultdual.
* New libpari functions: absZ_factor_limit_strict,
bnf_build_cheapfu, bnf_compactfu, bnf_compactfu_mat,
bnf_get_sunits, bnf_has_fu, bnrchar_primitive_raw,
bnrconductor_factored, bnrconductor_raw, bnrisprincipalmod,
bnr_subgroup_check, checkbnr_i, checkfarey_i,
closure_callgen0prec, cmpss, cmpuu, cyc_get_expo, div_content,
ellQtwist_bsdperiod, etaquotype, expIPiC, expIPiR, F2m_row,
F2Ms_colelim, F2Ms_ker, F2Ms_to_F2m, F2m_to_F2Ms,
F2m_transpose, F2v_and_inplace, F2v_hamming,
F2v_negimply_inplace, F2v_or_inplace, F2xn_inv, F2xn_red,
F2xqX_halfgcd, F2xX_to_F2xC, F2xXV_to_F2xM, factorial_Fl,
factorial_Fp, famat_div, famat_idealfactor, famat_nfvalrem,
famat_remove_trivial, famatV_factorback, famatV_zv_factorback,
ff_parse_Tp, FFX_add, FFX_halfgcd, Flv_factorback, Flx_blocks,
Flx_Fl_sub, Flx_is_totally_split, Flxn_expint, Flxq_autpowers,
FlxqV_factorback, FlxqX_fromNewton, FlxqX_Newton,
FlxqXn_expint, FlxqXn_inv, FlxqXn_mul, FlxqXn_sqr,
Flx_translate1_basecase, FlxV_Flv_multieval, FlxX_blocks,
FlxX_invLaplace, FlxX_Laplace, FlxXn_red, FlxX_translate1,
forqfvec1, FpV_prod, FpXC_to_mod, FpX_divu, FpX_Fp_div,
FpX_FpXV_multirem, FpXM_to_mod, FpXn_expint, FpXQXn_expint,
FpXV_chinese, FpXY_FpXQ_evaly, FqC_FqV_mul, FqC_to_mod,
FqV_factorback, FqXC_to_mod, FqX_expint, FqXM_to_mod,
galoismatrixapply, gc_const, gen_sort_shallow, gen_ZpM_Newton,
groupelts_conj_set, groupelts_quotient, groupelts_to_group,
group_subgroup_is_faithful, halfgcdii, hash_zv,
idealfactor_partial, ideallogmod, ideallog_units,
ideallog_units0, idealpseudominvec, Idealstarmod, init_Flxq,
is_qfb_t, Kronecker_to_ZXQX, lfunquadneg, minim_zm,
mseval2_ooQ, mspadic_parse_chi, mspadic_unit_eigenvalue,
nf_cxlog, nf_cxlog_normalize, nfhyperellpadicfrobenius,
nflogembed, nfsign_fu, nfsign_tu, nfV_cxlog, nfX_disc,
nfX_resultant, pariplot, pari_realloc_ip, pow2Pis, pow2Pis,
powPis, powPis, QabM_tracerel, Qab_tracerel, QabV_tracerel,
Qdivis, Qdiviu, Q_lval, Q_lvalrem, QM_gauss_i, QM_image,
QM_image_shallow, QM_ImQ, QM_ImQ_all, QM_ImZ, QM_ImZ_all,
QM_sqr, quotient_groupelts, QXQ_to_mod_shallow, QXQX_gcd,
QXQX_mul, QXQX_powers, QXQX_QXQ_mul, QXQX_sqr, radicalu,
random_zv, rfracrecip, RgM_ZM_mul, RgV_type, RgV_type2,
RgX_halfgcd, RgXn_expint, RgXV_to_FlxV,
rnf_get_ramified_primes, SL2_inv_shallow, sumdivmultexpr,
sunits_makecoprime, uis2psp, uispsp, upowers, vec_equiv,
vecfactorsquarefreeu_coprime, vec_reduce, vecsmall_is1to1,
vecsmall_isconst, vecvecsmall_sort_inplace,
vecvecsmall_sort_shallow, Vgaeasytheta, ZC_u_divexact,
zlx_translate1, zlxX_translate1, ZMrow_equal0, ZpM_invlift,
ZpX_primedec, ZV_lcm, ZV_snf_gcd, zv_sumpart, ZX_compositum,
zx_lval, ZXQ_minpoly, ZXQ_powers, ZXQX_gcd, ZXQX_ZXQ_mul,
ZX_realroots_irred, ZX_sturm_irred, ZXX_evalx0, ZXX_Q_mul,
zx_z_divexact,
* Allow nfinit([T, basis, ramified primes]).
* Allow nf.p, rnf.p [rational ramified primes].
* Add flag bit to ZM_snfall_i.
* Allow real t_QUAD in floor, ceil, divrem, %, \, \/.
* Parallel support for lfuninit.
* Direct formulas for quadratic Dirichlet L-functions at integers.
* lfuncreate: support for closures of arity 0.
* Compact representation of units in bnf (bnfinit(pol,1)) and of
principal ideal generators (bnfisprincipal(bnf,id,4)).
* lfuncreate(znstar or bnr,): allow a vector of characters =>
vector-valued L-function.
* Holes in multi-assignement: [a,,c]=[1,2,3].
* nfisincl: new flag: return a single embedding.
* qflll(x,3) in place reduction: return x * qflll(x) (faster).
* galoisinit: support for group (3x3):4 (GAP4(36,9)).
* Removed obsolete function rootsof1_kannan: use nfrootsof1.
* Removed obsolete function checkbnrgen: use bnr_get_gen.
* For additional changes, see the included changelog.
- Update to release 2.12.0.
* New functions in GP: airy, arity, bnrclassfield, derivn,
dirpowers, ellE, ellK, export, exportall, ffmaprel,
getlocalbitprec, getlocalprec, hypergeom, idealdown,
idealismaximal, mfgaloisprojrep, nfdiscfactors, pollaguerre,
polteichmuller, strjoin, strsplit, strtime, unexport,
unexportall.
* New libpari functions: bid_get_fact2, closure_derivn,
constzeta, divisorsu_fact_factored, divisorsu_moebius,
F2xqX_disc, F2xqX_resultant, F2x_recip, F2x_Teichmuller,
FF_preimagerel, FF_var, FFX_disc, FFX_extgcd, FFX_gcd,
FFXQ_minpoly, FFX_resultant, Flx_fromNewton, Flx_integ,
Flx_invLaplace, Flx_Laplace, Flx_Newton, Flxn_exp, Flxn_red,
Flxn_sqr, FlxqX_disc, FlxqX_resultant, Flx_Teichmuller,
Fp_divu, FpXC_FpXQ_eval, FpXQX_disc, FpXQX_resultant, gc_bool,
gc_double, gc_int, gc_long, gc_NULL, gc_ulong,
gluncloneNULL_deep, guncloneNULL, hash_init, hash_init_ulong,
has_str_len, identity_zv, identity_ZV, maxprimeN, mpsinhcosh,
mulu_interval_step, nfX_to_monic, nonsquare_Fl,
pari_get_histrtime, polint_i, polintspec, pollegendre_reduced,
psi1series, qfiseven, rfrac_deflate, rfrac_deflate_max,
rfrac_deflate_order, RgV_is_arithprog, RgV_isin_i, set_avma,
setunion_i, walltimer_delay, walltimer_start, ZpXQX_liftroots,
zv_cyc_minimal, zv_cyc_minimize, ZXQ_powu.
* qfbsolve(Q,n) now supports arbitrary integer n.
* limitnum/asympnum: allow closures of the form
N->[u(1),...,u(N)], which allows to handle efficiently sums,
recursions, continued fractions, etc.
* Optional flag to pollegendre and polhermite.
* Allow subst(e, x, vector v) for vector(subst(e, x, v[i])).
* Optional v argument to nfmodprinit.
* Support call by reference in GP function: f(~L,x)=listput(~L,x+1).
* Generic fast linear algebra using CUP decomposition.
* Implement lfunmfspec in odd weight.
* Support for rational model in ellratpoints and hyperellratpoints.
* Fast algorithm for zeta([a + b*n | n<-[0..N]]).
* ellheight(E) now returns the Faltings height of E.
* lfun now allows non-integral weights.
* example/parigp.sty to re-enable PARI's \pmatrix with amsmath.
* Removed member functions .futu and .tufu (deprecated since 2.2).
* Removed inferior hash function hash_str2: use hash_str.
* Removed obsolete binary flag '2' in matsnf (make it a no no-op).
* For additional changes, see the included changelog.
-------------------------------------------------------------------
Sat Jun 6 23:59:38 UTC 2020 - Jan Engelhardt <jengelh@inai.de>
- Update to release 2.11.4
* fixed "factor((x-1)*(x-y)^2)" going into an infinite loop
* "ellap" could fail with division by 0
* cure wrong results from "bnfsunit"
-------------------------------------------------------------------
Thu Mar 5 16:44:44 UTC 2020 - Jan Engelhardt <jengelh@inai.de>
- Update to release 2.11.3
* Avoid division by zero in Flx_extresultant when one input is 0.
* Fix crashes executing "ispower(27,2^60)",
"issquare(non square t_FFELT, &x)",
"polcompositum(x^2+x/3+1,x^2+x/3+1)",
"polrootsreal(x+0.)", "qflllgram([2,2,3;4,5,6])",
or printf("%10.6f\n",2^-100).
-------------------------------------------------------------------
Fri Aug 23 13:49:16 UTC 2019 - Jan Engelhardt <jengelh@inai.de>
- Enable pthreads [boo#1142714]
- Avoid duplicate shipping of documentation.
-------------------------------------------------------------------
Sun Jul 28 22:37:35 UTC 2019 - Simon Puchert <simonpuchert@alice.de>
- Update to new upstream release 2.11.2
* Fixed minpoly(Mod(1,t^2)) causing SIGSEGV.
* Fixed segfault in ffinvmap(m) on bad input.
* Fixed factormod(x^3+1,[y^2+1,2]) causing SIGSEGV.
* Fixed incorrect use of graphcolors leading to a SIGSEGV.
* Fixed [a,b]=a possibly leading to memory corruption.
* Fixed a memory leak in cgetalloc when lg overflows.
* Fixed a possible segfault in padicappr.
* Fixed core() possibly destroying its input,
if stored in a GP variable.
* Fixed stack corruption in quad_disc.
* Fixed an infinite loop and stack corruption in ellmoddegree.
- Drop the separate changelog as RPMLINT warns about it being a
duplicate of the file CHANGES (which is already included).
-------------------------------------------------------------------
Mon Mar 25 19:08:37 UTC 2019 - Christophe Giboudeaux <christophe@krop.fr>
- Prepare the KDE4/Qt4 removal in factory.
-------------------------------------------------------------------
Mon Dec 10 23:51:20 UTC 2018 - Jan Engelhardt <jengelh@inai.de>
- Update to new upstream release 2.11.1
* Fixed a heap buffer overflow
* Fixed mfsplit(mf,,flag) could return uninitialized objects
causing SIGSEGV
* Fixed incgam(-1000.4,2) causing SIGSEGV
* Fixed mfcoefs(mfDelta(),0) causing SIGSEGV
* Fixed segfault in rnfidealup
-------------------------------------------------------------------
Fri Dec 7 21:14:49 UTC 2018 - Todd R <toddrme2178@gmail.com>
- Use %macro instead of %{macro} wherever possible.
-------------------------------------------------------------------
Fri Dec 7 16:38:08 UTC 2018 - Todd R <toddrme2178@gmail.com>
- Fix building on SLE 15
- Use %license macro
-------------------------------------------------------------------
Wed Aug 29 20:32:25 UTC 2018 - Jan Engelhardt <jengelh@inai.de>
- Update to new upstream release 2.11.0
* fixed uninitialized memory reads in lgcdii and red_montgomery
* fixed memory leaks on pari_close [s_dbginfo, s_frame,
colormap/graphcolor
* polcoeff is deprecated and renamed polcoef: it now only
applies to scalars, polynomials, series and rational
functions; no longer to vector/matrices or quadratic forms
(use [] or "component")
* libpari: rename polcoeff0 -> polcoef, polcoeff_i -> polcoef_i,
truecoeff -> truecoef
-------------------------------------------------------------------
Sat Sep 9 12:33:24 UTC 2017 - jengelh@inai.de
- Update to new upstream release 2.9.3
* Expression "issquare(Mod(1,67)*x^4+Mod(14,67)*x^2+Mod(49,67))"
and "polroots(t_POL whose coeffs vary by a factor > 2^100000)"
had caused SIGSEGV
-------------------------------------------------------------------
Tue Feb 21 00:00:10 UTC 2017 - jengelh@inai.de
- Update to new upstream release 2.9.1
* lfunartin was using too much stack
* fflog in char 3 or 5 was slower than intended
* modular algorithms could fail for very large input
-------------------------------------------------------------------
Tue Nov 29 11:45:37 UTC 2016 - jengelh@inai.de
- Update to new upstream release 2.9.0
* fixed nfisisom(x,x^0) causing a crash
* fixed crash on BIB in ellpointtoz(t_PADIC)
* fixed wrong result for nfroots(non-monic t_POL)
* fixed division by zero on doing
e=ellinit([1,-1,1,98,126],O(5^10)); ellpointtoz(e,[1,14])
* fixed rare crash in bnfisprincipal
-------------------------------------------------------------------
Sun Jul 31 16:46:14 UTC 2016 - jengelh@inai.de
- Update to new upstream release 2.7.6
* fixed O(1)==O(x) returning 0
* matsolve(a,b) and a^(-1) gave wrong results [or SEGV] when t_MAT
a was not square and a,b "modular"; same for x^(-1)
* fixed a memory leak in pari_close: sopath was not freed
-------------------------------------------------------------------
Sat Mar 12 20:32:55 UTC 2016 - jengelh@inai.de
- Update to new upstream release 2.7.5
* forprime engine could skip (fast) sieve in favour of (slow)
* corrected return values/exceptions of functions
-------------------------------------------------------------------
Thu Feb 26 12:42:06 UTC 2015 - jengelh@inai.de
- Update to new upstream release 2.7.3
* "??bnrL1" and "??ellL1" did not work anymore and were fixed
* thue(f^e*g, ...), e even, (f,g)=1 missed solutions such that f<0
* nfisincl(t_POL, t_POL) could lead to wrong negative results
* ellcard over non-prime fields could return wrong results
* weber(1+I) was missing its imaginary part
-------------------------------------------------------------------
Sun Oct 12 08:15:21 UTC 2014 - jengelh@inai.de
- Update to new upstream release 2.7.2. Fixed were:
* (gp -p N) or (primelimit=N in gprc_ for N >= 436273290 resulted
in an incorrect primetable.
* monomial(exact zero, d, v) returned an invalid t_POL / t_RFRAC
* contfracpnqn(v, n) returned partial quotients p[-1]/q[-1] ...
p[n-1]/q[n-1], instead of the documented p[0]/q[0] ... p[n]/q[n]
* iferr() could crash if some component of the t_ERROR were clones
* nffactor() could overflow the stack when default accuracy too low
* obsolete use of E=[a1,a2,a3,a4,a6] in ellmul crashed
* incorrect rounding in mulrr/divrr for one-word precision reals
* multiif did not handle correctly return() in conditions
* is_gener_Fp could return wrong results
* Fq_sqrtn(t_INT,..,&zeta) could return a wrong root of 1
* bnfinit: SEGV due to precision issues
* zm_zc_mul only worked for square zm matrices
* [gphelp] infinite loop when $COLUMNS too small
* factoru(1) returned a t_MAT instead of the expected "matsmall"
* when compatible = 3; series() used a random precision
* isprime() could crash on large input
* gphelp did not handle === correctly
-------------------------------------------------------------------
Wed Aug 6 05:14:57 UTC 2014 - jengelh@inai.de
- Update to new upstream release 2.7.1
* Q_pvalrem(t_FRAC) returned a wrong result
* The "ellheegner" function was using too much memory in some cases
* nfhilbert(K,x,y, P above 2) could give wrong results
* nfpow_u didn't handle non-integral rational numbers
* nfroots(, t_POL with leading coeff -1) could miss solutions
-------------------------------------------------------------------
Fri Apr 18 14:53:48 UTC 2014 - jengelh@inai.de
- Update to new upstream release 2.7.0
* added new library functions FlxX_to_FlxC, FlxXV_to_FlxM, polx_FlxX,
Flx_lead, RgV_to_RgM
-------------------------------------------------------------------
Wed Feb 5 01:56:32 UTC 2014 - jengelh@inai.de
- Update to new upstream release 2.5.5
* sin'(1) with default(compatible,3) caused a crash
* add missing call to normalize() in lift(t_POL/t_SER)
* galoisinit(x^3+x^2-2*x-1) led to uninitialized read
* polred() could return non-squarefree polynomials
* bnrdisc could return a wrong result if the modulus had more than
2 prime divisors
* FFT mulii relied on unspecified order of evaluation
* local() could corrupt polynomial variable of the same name
- Add pari-nodate.diff
-------------------------------------------------------------------
Sun Jan 6 20:10:01 UTC 2013 - jengelh@inai.de
- Restore original library filename after confirming with upstream
(This change is transparent to all users)
-------------------------------------------------------------------
Thu Nov 29 19:09:42 UTC 2012 - jengelh@inai.de
- Update to new upstream release 2.5.3
* Fixed a bug whereby calling a GP function with a lot of omitted
arguments could crash
* idealramgroups() and idealfrobenius() did not accept a bnf
-------------------------------------------------------------------
Sun Feb 26 22:13:05 UTC 2012 - scorot@free.fr
- fix build requirement to allow build on SLE-11
- recompress source file to bzip2 format to allow build on SLE-11
- add missing %%post and %%postun scriptlets
-------------------------------------------------------------------
Mon Sep 26 08:52:28 UTC 2011 - jengelh@medozas.de
- Initial package (version 2.5.0) for build.opensuse.org