Up to [cvs.NetBSD.org] / pkgsrc / math / pari
Request diff between arbitrary revisions
Default branch: MAIN
Revision 1.87 / (download) - annotate - [select for diffs], Sun Jan 29 21:17:04 2023 UTC (8 weeks, 3 days ago) by ryoon
Branch: MAIN
CVS Tags: pkgsrc-2023Q1-base,
pkgsrc-2023Q1,
HEAD
Changes since 1.86: +2 -1
lines
Diff to previous 1.86 (colored)
*: Recursive revbup from graphics/freetype2
Revision 1.86 / (download) - annotate - [select for diffs], Sun Oct 30 10:00:15 2022 UTC (4 months, 4 weeks ago) by nros
Branch: MAIN
CVS Tags: pkgsrc-2022Q4-base,
pkgsrc-2022Q4
Changes since 1.85: +2 -3
lines
Diff to previous 1.85 (colored)
Update math/pari to version 2.15.0 Listed in the TODO and the version in pkgsrc was 7 years old. Fix pkglint complaints. The changes below are only for 2.13 to 2.15. The commit message would be to big if all changes were included. Changes from changelog: Bug numbers refer to the BTS at http://pari.math.u-bordeaux.fr/Bugs/ Done for version 2.15.0 (released 19/09/2022): Fixed 1- slowdown in zeta (e.g. zeta(Pi) at \p500) 2- GC error in idealinv [#2258] 3- qfminim inefficiency (initial bound from non-LLL-reduced matrix) 4- mfshimura in weight 3/2 => oo loop 5- zetahurwitz(s, huge x) => overflow or very slow 6- matsolve([1,1,1/2; 1,0,1/2; 2,1,0], [-1;1;-1]) -> SEGV [#2261] 7- qfminim(Mat(1),,,2) -> precision error [#2262] 8- subst(p, v, t_SER) very slow if p contains many variables [#2264] 9- mfsymboleval for trivial path returned 0 instead of a vector of 0s when f has multiple embeddings [#2260] 10- 2^(1 + O(3^4)) -> type error 11- 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) [#2265] 12- tan(1+10^20*I) -> overflow (same for cotan and psi) BA 13- Mod(2,3)^1000000000000000000001 -> Mod(-1,3) [#2266] 14- subst(O(y) + x, x, (1 - y + O(y^2))*x + O(x^2)) -> SEGV [#2267] 15- (Mod(0,3) + x) + O(x^2) -> x + O(x^2) [now Mod(1,3)*x + O(x^2)] 16- precision too low for units in mfgaloisprojrep 17- missing GC at the end of RgXn_inv 18- (-1)^(1/3) -> -1 instead of exp(log(-1)/3) 19- mfeisenstein(k, trivial characters mod N > 1) not handled correctly BA 20- missing GC in qfsolve 21- missing GC in nfeltval + better algorithm when valuation is huge 22- rnfidealup(, non-integral ideal) -> division by 0 23- memory leak in ellheight 24- memory leak in bnfinit 25- zeta(-2 + O(x)) => division by 0 26- nfeltdiv(nfinit(x^2+1), 0, 1+x/2) -> SEGV [#2277] 27- numerical instability in polinterpolate [#2278] 28- znchargauss(g,chi,0) -> oo loop 29- bnflog(bnr, ...) -> SEGV 30- elliptic functions: incorrect reduction of z/w1 mod [1,tau] => catastrophic cancellation 31- powcx(x, t_COMPLEX with 0 imaginary part) -> crash 32- nfsubfields(t_POL in other var than x,,1) -> SEGV 33- extra terms in power t_SER substitutions [#2281] f=1+4*t^2+36*t^4+O(t^6); g=q-4*q^3+14*q^5+O(q^7); subst(f,t,g) -> spurious extra term -400*q^6 34- k=bnfinit(quadpoly(-2923,a)); bnrclassfield(k,3) -> SEGV [#2280] BA 35- rnfdisc mishandled polynomials with denominators [#2284] BA 36- elltamagawa(ellinit([-1456/243,93184/19683])) -> wrong result 37- mfsearch would sometimes miss the trivial form 38- typo in allh [affects ECPP tunings] HC 39- mfisetaquo(mffrometaquo([1,12;193,12])) -> 0 40- polroots(1.E-47*t^6 + 1.E-47*t^5 + 4.E-46*t^4) -> bug in type [#2286] 41- ceil(quadgen(5)) -> 1 instead of 0 [#2288] 42- floor(Mod(0,3)*quadgen(5)) -> crash 43- padicappr(x^2+1, 1/3+O(3)) -> missing valuation and type checks 44- padicappr(x^2+25,5+O(5^2)) -> [O(5),O(5)] instead of [2*5+O(5^2),3*5+O(5^2)] 45- wrong ispower(t_RFRAC) and issquare(t_RFRAC, &z) [#2289] 46- slow series substitution if valuation huge f=t^50000+O(t^50001); g=q*Ser(vector(50000,i,1),q); h=subst(f,t,g) 47- 1+O(x)==O(x) 48- cmp() would use possibly uninitialized bits in t_POL codewords BA 49- qfauto([[1,0;0,1],[0,0;1,0]]) -> SEGV 50- 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 ] BA 51- rnfdisc could return corrupted result 52- quadtofp suffered from catastrophic cancellation [#2298] z=66992092050551637663438906713182313772 -47370562574818466708936539960450008968*quadgen(8); z*1. -> 0.75 BA 53- concat(List([1])[1..0]) ->SEGV (instead of error) [#2299] BA 54- List([1])[1..0]==List() -> 0 instead of 1 55- ZX_squff(T) did not follow its specification if T(0) = 0 56- (-1)^(-1/2) -> I instead of -I 57- lfuntheta inaccurate in large weight [#2305] 58- GC error in ZX_Uspensky(, flag = 0) BA 59- ellisomat(ell/nf not integral) -> oo-loop or wrong result BA 60- (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] 61- hypergeom([1/12,1/12],2/3,3) -> wrong result (incorrect limiting case of transformation formula) 62- overflow in mulu_interval(,ULONG_MAX) [#2309] 63- ellE(1) -> domain error [#2312] 64- log1p(-1 + 10^-10) -> oo time 65- bernvec entries were wrong from B_{2*4064} on [#2311] 66- plotrecthraw for multi-curves 67- RgXn_powu(,,1) wrong result [#2314] 68- erfc incorrect on negative imaginary axis [#2315] 69- mfgalpoistype bug for dihedral types (when conductor at oo is not stable under Galois) [#2293] BA 70- [32bit] forfactored(n=223092868, 223092871, ) -> SEGV [#2318] 71- Fp_issquare(0, p) would return 0 72- For z=x+wy a t_QUAD, z.pol returned the modulus z.mod instead of the t_POL x+'w*y 73- allow eulerianpol(0) (= 1) 74- allow polylog(0,x) (was broken when eulerianpol was introduced) BA 75- concat(t_LIST,t_LIST) was leaking memory 76- missing type checks in ellchangepoint (SEGV) 77- polsturm(-5500*x^4+440*x^3+21780*x^2-9680*x-29040,[-oo,-4])->corruption 78- ellheight(E,,Q) -> SEGV 79- besselj(80,66) -> oo loop 80- lfun(1, 0.0) "normalizing a series with a 0 leading term" [#2329] 81- (0. + O(x) == 1) returned 'true' 82- lfun(1, 0., 1) -> division by 0 83- fix lfuncost when root number is unknown (more a_n are needed) 84- idealismaximal(nfinit(x),Mat(2)) -> 0 [#2333] 85- O(29^(-1)) == 1 was FALSE (same for -1) 86- Mod(0, 2*x^0) == 1 was FALSE (same for -1) BA 87- [X11] resizing a window could keep traces of previous drawing BA 88- x->x+0x1 was not displayed correctly 89- bnfinit(Q) was not using current precision [#2335] 90- lfuncreate(x^2 + 1/2) -> internal error. Allow rational coefficients. 91- polresultant(t_POL with t_RFRAC coefs,...) -> internal errors 92- znchardecompose(znstar(2,1),[],2) -> SEGV [#2339] 93- genus2red(150*x^6+180*x^5-270*x^4+2040*x^3-1350*x^2+3060*x+270) -> internal bug [#2331] 94- missing roots in nfroots(t_POL,) [#2345] 95- factorpadic: ensure leading coefs are powers of p [#2352] 96- nfsnf: wrong results [#2353] XR 97- rare SEGV in nfdisc. [#2356] BA 98- factor((Mod(1,2)*((t^2+1)*x^4+(t^4+1)*x^2+1))) -> division by 0 99- internal type errors in mfsymboleval [#2360] 100- incorrect chargalois for trivial group [#2341] 101- minpoly(Mod(1/(x-(t+1))*Mod(1,2),(t+1)*x^2+t*x+1)) -> error [#2363] BA 102- factor(Mod(1,2)*x^5+a*x^3) -> div by 0 AP 103- nfgrunwaldwang: fix infinite loop [#2343] 104- ti=thueinit(3*x^3 + 5*x^2 - 14*x + 54,1); thue(ti,1) -> error [#2365] 105- algdep(t_POLMOD x) -> x.mod instead of correct result 106- bnrinit(,,,cycmod) failed to delete elementary divisors equal to 1 BA 107- bnrclassfield: incorrect result when fundamental units are large, e.g. bnrclassfield(bnfinit(nfsplitting(a^3-a^2-202*a-3080),1),2) [#2371] 108- M8=mfinit([8,5/2]); mfatkininit(M8,8)[1] was 0 and shouldn't be 109- polylogmult instability default(realprecision,366);a=(1+sqrt(5))/2;w=(1+sqrt(-3))/2; polylogmult([1,1,1,1],[1/a,a,1,w]) -> error 110- valuation(x*(y^2-1), y+1) -> oo loop [#2381] 111- round(t_FRAC, &e): e was always -oo 112- FpM_center_inplace would crash for p = 3 [#2387] BA 113- [gp interpreter] fix memory leak in pop_lex 114- numerator(1/x+1/y, 'x) -> x*y 115- colors = "no" (or "") handled incorrectly [#2402] 116- thue(thueinit(x^3-3*x^2+1,1), 2187) -> domain error in mplog [#2397] 117- Bessel function of huge order -> oo loop [e.g. besselj(220, 112)] 118- elltwist(E,) would ignore E's real precision Added HC 1- new GP function eulerreal BA 2- fplll: fast, dpe and heuristic variants 3- dirpowerssum: allow a completely multiplicative function 4- [libpari] atanhuu, atanhui, powcx, powcx_prec, cx_approx0 5- new GP function lfunparams (initial implementation P. Molin) 6- [libpari] row_Q_primpart BA 7- [libpari] RgXQ_trace, RgX_chinese_coprime, RgXQV_factorback 8- [libpari] FpM_intersect_i, Flm_intersect_i HC 9- add optional argument to ramanujantau + parallelize code HC 10- new GP functions bessljzero, besselyzero BA 11- [libpari] Fle_ellweilpairing, Fle_elltatepairing, Flj_to_Fle Fl_ellptors BA 12- [libpari] ZC_divexactu, ZM_divexactu HC 13- allow hypergeom(N, D, t_SER) 14- [libpari] qfbsqr, qfbcomp, qfbpow, qfbpowraw, qfbsqr_i, qfbcomp_i, qfbpow_i, qfbpow, qfbpowraw, qfr3_compraw, qfr5_compraw 15- general composition of binary quadratic forms (in different orders) BA 16- New GP functions ellrank, ellrankinit : implement 2-descent on elliptic curve following a GP script by Denis Simon. BA 17- [libpari] RgXY_derivx, RgX_recip_i 18- [libpari] RgC_RgV_mulrealsym, RgM_to_RgXV_reverse BA 19- New GP function ellsaturation 20- [libpari] ZX_Z_eval BA 21- [libpari] elltors_psylow 22- ellinit([j]); no need to use ellfromj 23- ideallist(nf, negative bound) to return ideals of norm |bound| (in factored form) 24- rnfconductor(bnf,pol,flag): add flag=2 to only return the conductor and its factorization (which comes for free) HC 25- New GP functions nflist, nfresolvent BA 26- [libpari] Hermite_bound 27- substvec: support t_VEC replacement values BA 28- New GP function ell2cover BA 29- nfsplitting: flag to get the embedding BA 30- New GP function galoissplittinginit HC 31- lambertw(y): support all values y > -1/e [#1472] HC 32- lambertw: add optional 'branch' argument; support and complex, p-adic and power series inputs BA 33- [libpari] ZXC_to_FlxC, ZXM_to_FlxM BA 34- [libpari] New function families F3v, F3m BA 35- New GP function setdebug 36- allow shortcut \g n feat for setdebug("feat", n) 37- New GP function poltomonic [#2200] 38- in GPRC, support default(key,val) and setdebug(dom,val) 39- New GP function polsubcyclofast 40- [libpari] prV_primes, ideals_by_norm, nfV_to_scalar_or_alg, quadpoly_i 41- new bit in nfinit flag: don't perform LLL on nf.zk BA 42- new flag value in nfisincl 43- [libpari] hclassno6u_from_cache, uhclassnoF_fact, hclassnoF_fact, vandermondeinverseinit, vandermondeinverse, trans_evalgen, sunits_mod_units, Qp_exp_prec BA 44- [libpari] RgXQ_minpoly 45- [libpari] quadclassnos, quadclassnoF, unegquadclassnoF, uposquadclassnoF, coredisc2_fact, coredisc2u_fact, uquadclassnoF_fact quadclassnoF_fact, Z_issquarefree_fact 46- new GP functions quadunitnorm, quadunitindex LGr 47- allow endpoints in solve() to by +oo or -oo 48- allow Vec(t_STR, n) and Vecsmall(t_STR, n) 49- new GP function: harmonic 50- allow digits(integral t_PADIC) 51- new GP function qfbcornacchia 52- [libpari] gc_all BA 53- [libpari] Zp_inv, Zp_invlift, Zp_div, Zp_log, Zp_exp BA 54- [libpari] FpXn_div, Flxn_div, RgXn_div, RgXn_div_i, FpXQXn_div, F2xn_div 55- [libpari] maxomegau, maxomegaoddu, ZV_snf_rank, ZV_snf_rank_u, zv_snf_rank, F3c_to_ZC, F3c_to_mod, F3m_to_mod, ZX_unscale_divpow, ZX_affine 56- new GP function snfrank HC 57- allow lngamma(t_PADIC of negative valuation) 58- file LICENSE (for Software Heritage archiving) BA 59- [libpari] RgXV_prod BA 60- new GP function serdiffdep 61- new module for hypergeometric motives, see ??hgm. GP functions hgmalpha hgmbydegree hgmcyclo hgminit hgmtwist hgmcoef hgmeulerfactor hgmissymmetrical lfunhgm hgmcoefs hgmgamma hgmparams BA 62- new GP function lfuneuler TF 63- new GP functions subcyclohminus, subcycloiwasawa, subcyclopclgp 64- new GP function bnrcompositum 65- [libpari] gdivgu, gdivgunextu, divrunextu, gmulgu, gmulug 66- [libpari] Zp_log, Zp_exp 67- new GP function intnumosc, sumnumsidi BA 68- [x86_64,arm64] AVX,NEON support for hyperellratpoints BA 69- [libpari functions ZX_digits, ZXV_ZX_fromdigits NM 70- new GP function elltrace BA 71- [libpari] FpXQXV_red, FpXQXT_red BA 72- [libpari] ZpXQX_ZpXQXQ_liftroot, ZqX_ZqXQ_liftroot 73- [libpari] ZV_snfclean 74- allow bnrchar to construct a Dirichlet character (with a znstar input) 75- new GP functions nfeltissquare, nfeltispower BA 76- [libpari] FlxqX_nbfact_by_degree BA 77- [libpari] RgXY_cxevalx 78- allow f*g and f^n for qfbcomp/qfbpow also for extended (real) forms 79- [libpari] qfbpows BA 80- [libpari] FlxM_to_FlxXV, FlxXC_sub BA 81- [libpari] FlxqXC_FlxqXQ_eval, FlxqXC_FlxqXQV_eval BA 82- new GP function qfminimize BA 83- new GP functions hyperelldisc, hyperellminimalmodel, hyperellminimaldisc, hyperellred 84- new GP function setdelta BA 85- [libpari] RgX_homogenous_evalpow, QXQX_homogenous_evalpow BA 86- [libpari] FpX_roots_mult BA 87- [libpari] RgX_affine HC 88- new GP function lerchphi, lerchzeta BA 89- new GP function hyperellisoncurve BA 90- [libpari] nfM_ker 91- [libpari] Qp_zeta BA 92- [libpari] RgX_mul2n 93- [libpari] rfrac_to_ser_i 94- [libpari] FlxC_FlxqV_eval_pre, FlxC_Flxq_eval_pre, Flx_FlxqV_eval_pre, Flx_Flxq_eval_pre, Flx_Frobenius_pre, Flx_div_pre, Flx_divrem_pre, Flx_extgcd_pre, Flx_gcd_pre, Flx_get_red_pre, Flx_halfgcd_pre, Flx_mul_pre, Flx_oneroot_pre, Flx_oneroot_split_pre, Flx_rem_pre, Flx_roots_pre, Flx_sqr_pre, Flxq_div_pre, Flxq_inv_pre, Flxq_invsafe_pre, Flxq_mul_pre, Flxq_powers_pre, Flxq_powu_pre, Flxq_sqr_pre, Flx_powu_pre, Flxn_div_pre, Flxn_mul_pre, Flxn_sqr_pre, FlxqX_fromNewton_pre, FlxqX_Flxq_mul_pre, FlxqX_Flxq_mul_to_monic_pre, FlxqX_FlxqXQV_eval_pre, FlxY_FlxqV_evalx_pre, FlxY_Flxq_evalx_pre, FlxqX_Newton_pre, FlxqX_get_red_pre, FlxqX_invBarrett_pre, FlxqX_powu_pre, FlxqXn_mul_pre, FlxqXn_sqr_pre, FlxqXn_inv_pre, FlxqXn_expint_pre, FlxY_eval_powers_pre, FlxY_evalx_powers_pre, FlxY_evalx_powers_pre, FlxqX_divrem_pre, FlxqXQ_inv_pre, FlxqXQ_invsafe_pre, FlxqXQ_sqr_pre, FlxqX_rem_pre, FlxqX_sqr_pre, FlxqXQ_pow_pre, FlxqXC_FlxqXQV_eval_pre, FlxqXQ_div_pre, FlxqXQ_mul_pre, FlxqX_halfgcd_pre, FlxqX_mul_pre, FlxqX_extgcd_pre, FlxqXQ_powers_pre, FlxqXQ_powu_pre, FlxqX_normalize_pre, FlxqX_red_pre, Kronecker_to_FlxqX_pre, Flx_dotproduct_pre, FlxqX_div_pre, FlxY_Flxq_evalx_pre, FlxqXC_FlxqXQV_eval_pre, Flx_is_smooth_pre, Flxq_pow_pre, Flxq_pow_init_pre, Flxq_pow_table_pre, Flx_matFrobenius_pre, FlxqV_dotproduct_pre, FlxqX_FlxqXQ_eval_pre, Flxq_auttrace_pre, Flxq_minpoly_pre, Flxq_lroot_fast_pre, Flxq_lroot_pre Flxq_matrix_pow_pre, Flx_ddf_pre, Flx_factor_squarefree_pre, Flx_nbfact_pre, Flx_nbfact_Frobenius_pre, Flx_resultant_pre, Flxq_autpow_pre, FlxqX_gcd_pre, FlxY_evalx_pre, FlxqXQ_autsum_pre, FlxqXQ_minpoly_pre, FlxqXQ_autpow_pre, FlxqXQ_auttrace_pre, FlxqX_Frobenius_pre, FlxqX_factor_squarefree_pre, FlxqE_weilpairing_pre TF 95- new GP function factormodcyclo TF 96- new libpari functions FpX_factcyclo, Flx_factcyclo 97- new libpari functions ZV_sort_shallow, ZV_sort_uniq_shallow, tridiv_boundu BA 98- rnfabelianconjgen 99- new libpari functions abmap_kernel, abmap_subgroup_image, ZV_ZV_mod, ZM_ZV_mod 100- bnr_char_sanitize, bnr_subgroup_sanitize TF 101- GP function znsubgroupgenerators 102- [libpari] RgV_is_prV 103- improve idealfactorback [using ideamulpowprime] Changed HC 1- faster implementation of eulervec + cache result 2- sumnummonieninit(,1): faster algorithm (complex step) 3- atanh(rational) now uses binary splitting BA 4- FqV_to_FlxV, FqC_to_FlxC, FqM_to_FlxM: replaced by ZXC_to_FlxC, ZXM_to_FlxM 5- FpM_intersect and Flm_intersect now guaranteed to return an Fp-basis; use FpM_intersect_i if you only need a generating set 6- ZXX_to_Kronecker -> RgXX_to_Kronecker, ZXX_to_Kronecker_spec -> RgXX_to_Kronecker_spec 7- [libpari] nbessel -> ybessel 8- faster implementation of mfinit and mfbasis in weight 1 9- ZabM_ker: replace final exact check by probabilistic check modulo a 63-bit prime 10- [libpari] ZC_u_divexact -> ZC_divexactu 11- unify real and imaginary binary quadratic forms, include discriminant types t_QFI and t_QFR are replaced by t_QFB 12- allow Qfb([a,b,c]) and Vec(t_QFB) 13- qfbredsl2(q, S): change format of S: was [D,isD], is now isD BA 14- [libpari] gp_read_stream now return NULL when EOF is reached (was gnil) 15- elltwist now returns an ellinit, and accepts the same input formats as ellinit ([a1,a2,a3,a4,a6], [a4,a6], Cremona label) 16- gen_search / vecvecsmall_search: remove flag; the result is now positive if the element is found else -i if element should be inserted at position i. 17- allow t_COL of objects in gconcat1 / shallowconcat1 18- [libpari] Z_smoothen now uses (and returns) t_VEC arguments. Use Z_lsmoothen to input small primes as a t_VECSMALL. 19- poliscyclo: replace Bradford-Davenport's Graeffe method by their invphi algorithm (much faster) BA 20- [libpari] QXX_QXQ_eval renamed to QXY_QXQ_evalx 21- [libpari] ZX_Zp_root(f,a,p,): assume 0 <= a < p BA 22- [libpari] gen_factorback now take an extra parameter one. 23- [libpari] mplambertx_logx, mplambertX, mplambertxlogx_x 24- [libpari] absZ_factor_limit_strict no longer guarantees that q is composite: this is useless for applications and possibly expensive 25- default(debugfiles,) is now obsolete, use setdebug("io",) 26- [libpari] quadclassno now has a second argument (to recover the attached fundamental discriminant) 27- faster qfbclassno for non fundamental positive discriminants (use quadunitindex) 28- removed appa.tex from users.dvi; inline the text in INSTALL.tex 29- divrunu, divgunu: use a single division in all cases (faster even if denominator has 2 words) 30- allow random(negative integer N) -> a random integer in [-n,n], n=|N|-1. 31- allow sqrtint and sqrtnint for nonnegative real number argument 32- allow logint for positive real number argument 33- improve gamma and lngamma for t_FRAC inputs 34- renamed normalize -> normalizeser 35- nfinit/nfdisc/nfbasis: use lazy factorization by default [#2326] 36- in idealtyp(ideal, fa), allow setting fa to NULL BA 37- system now return the shell return value. 38- allow valuation(x) when x is a t_PADIC, a t_POL or a t_SER 39- libpari function precision() now always return a 'prec' (integer > 2). It used to return 2 for real 0 of non-negative exponent. 40- grndtoi(GEN x, long *e): allow setting e = NULL BA 41- [libpari] pari_thread_start: do not allow threads started this way to launch more threads. BA 42- genus2red: 3rd component is now a pair [P,Q] such that y^2+Q*y=P is minimal everywhere. 43- faster implementation of binomial Removed 1- [libpari] obsolete functions qfi, qfr, qfi_1, qfr_1, redreal, redrealnod, rhoreal, rhorealnod, qfrcomp, qfrcompraw, qfrsqr, qfrsqrraw, qfisqrraw, qficompraw, qfipowraw, qfipow, qficomp, qfisqr, redimag 2- [libpari] obsolete types t_QFI, t_QFR 3- [libpari] nfinitall is now obsolete; use nfinit with the same arguments 4- [libpari] order is now obsolete; use znorder
Revision 1.85 / (download) - annotate - [select for diffs], Sat Oct 29 18:28:06 2022 UTC (4 months, 4 weeks ago) by nros
Branch: MAIN
Changes since 1.84: +3 -2
lines
Diff to previous 1.84 (colored)
pari: fix work directory referance to gzip tool
Revision 1.84 / (download) - annotate - [select for diffs], Tue Jun 28 11:34:44 2022 UTC (9 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2022Q3-base,
pkgsrc-2022Q3
Changes since 1.83: +2 -2
lines
Diff to previous 1.83 (colored)
*: recursive bump for perl 5.36
Revision 1.83 / (download) - annotate - [select for diffs], Mon May 24 19:53:03 2021 UTC (22 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2022Q2-base,
pkgsrc-2022Q2,
pkgsrc-2022Q1-base,
pkgsrc-2022Q1,
pkgsrc-2021Q4-base,
pkgsrc-2021Q4,
pkgsrc-2021Q3-base,
pkgsrc-2021Q3,
pkgsrc-2021Q2-base,
pkgsrc-2021Q2
Changes since 1.82: +2 -2
lines
Diff to previous 1.82 (colored)
*: recursive bump for perl 5.34
Revision 1.82 / (download) - annotate - [select for diffs], Mon Aug 31 18:10:18 2020 UTC (2 years, 6 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2021Q1-base,
pkgsrc-2021Q1,
pkgsrc-2020Q4-base,
pkgsrc-2020Q4,
pkgsrc-2020Q3-base,
pkgsrc-2020Q3
Changes since 1.81: +2 -2
lines
Diff to previous 1.81 (colored)
*: bump PKGREVISION for perl-5.32.
Revision 1.81 / (download) - annotate - [select for diffs], Mon Aug 17 20:19:26 2020 UTC (2 years, 7 months ago) by leot
Branch: MAIN
Changes since 1.80: +2 -2
lines
Diff to previous 1.80 (colored)
*: revbump after fontconfig bl3 changes (libuuid removal)
Revision 1.80 / (download) - annotate - [select for diffs], Sun Aug 9 23:12:13 2020 UTC (2 years, 7 months ago) by joerg
Branch: MAIN
Changes since 1.79: +3 -4
lines
Diff to previous 1.79 (colored)
Don't leak tools-perl into config file. Bump revision. Avoid LOCALBASE and similar clean-up.
Revision 1.79 / (download) - annotate - [select for diffs], Fri May 22 17:45:24 2020 UTC (2 years, 10 months ago) by rillig
Branch: MAIN
CVS Tags: pkgsrc-2020Q2-base,
pkgsrc-2020Q2
Changes since 1.78: +1 -5
lines
Diff to previous 1.78 (colored)
math/pari: clean up REPLACE_PERL Two of the files now use autoconf to insert the correct Perl interpreter. The dependency "pre-install: replace-interpreter" was useless since then replace-interpreter would be run once in a direct "bmake update" or "bmake install", and twice in bulk builds since they first run "bmake build" and then "bmake install". And even in the latter case, replacing the interpreter twice had no effect since it was already replaced in the configure phase.
Revision 1.78 / (download) - annotate - [select for diffs], Sat May 2 13:37:08 2020 UTC (2 years, 10 months ago) by rillig
Branch: MAIN
Changes since 1.77: +1 -7
lines
Diff to previous 1.77 (colored)
math/pari: remove no-op SUBST block When building on NetBSD-8.0-x86_64, the file pari.cfg does not contain any references to TOOLS_DIR.
Revision 1.77 / (download) - annotate - [select for diffs], Sun Jan 26 17:31:39 2020 UTC (3 years, 2 months ago) by rillig
Branch: MAIN
CVS Tags: pkgsrc-2020Q1-base,
pkgsrc-2020Q1
Changes since 1.76: +2 -2
lines
Diff to previous 1.76 (colored)
all: migrate homepages from http to https pkglint -r --network --only "migrate" As a side-effect of migrating the homepages, pkglint also fixed a few indentations in unrelated lines. These and the new homepages have been checked manually.
Revision 1.76 / (download) - annotate - [select for diffs], Sun Aug 11 13:21:52 2019 UTC (3 years, 7 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2019Q4-base,
pkgsrc-2019Q4,
pkgsrc-2019Q3-base,
pkgsrc-2019Q3
Changes since 1.75: +2 -2
lines
Diff to previous 1.75 (colored)
Bump PKGREVISIONs for perl 5.30.0
Revision 1.75 / (download) - annotate - [select for diffs], Wed Aug 22 09:45:41 2018 UTC (4 years, 7 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2019Q2-base,
pkgsrc-2019Q2,
pkgsrc-2019Q1-base,
pkgsrc-2019Q1,
pkgsrc-2018Q4-base,
pkgsrc-2018Q4,
pkgsrc-2018Q3-base,
pkgsrc-2018Q3
Changes since 1.74: +2 -2
lines
Diff to previous 1.74 (colored)
Recursive bump for perl5-5.28.0
Revision 1.74 / (download) - annotate - [select for diffs], Mon Mar 12 11:17:03 2018 UTC (5 years ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2018Q2-base,
pkgsrc-2018Q2,
pkgsrc-2018Q1-base,
pkgsrc-2018Q1
Changes since 1.73: +2 -2
lines
Diff to previous 1.73 (colored)
Recursive bumps for fontconfig and libzip dependency changes.
Revision 1.73 / (download) - annotate - [select for diffs], Sat Sep 16 13:27:59 2017 UTC (5 years, 6 months ago) by tnn
Branch: MAIN
CVS Tags: pkgsrc-2017Q4-base,
pkgsrc-2017Q4,
pkgsrc-2017Q3-base,
pkgsrc-2017Q3
Changes since 1.72: +2 -1
lines
Diff to previous 1.72 (colored)
pari: uses perl unsafe @INC
Revision 1.72 / (download) - annotate - [select for diffs], Sat Jan 7 13:37:41 2017 UTC (6 years, 2 months ago) by leot
Branch: MAIN
CVS Tags: pkgsrc-2017Q2-base,
pkgsrc-2017Q2,
pkgsrc-2017Q1-base,
pkgsrc-2017Q1
Changes since 1.71: +1 -3
lines
Diff to previous 1.71 (colored)
termcap bl3 logic is already handled in devel/readline (pointed out by a typo in it) Discussed with <roy>
Revision 1.71 / (download) - annotate - [select for diffs], Thu Jan 5 21:13:53 2017 UTC (6 years, 2 months ago) by roy
Branch: MAIN
Changes since 1.70: +4 -3
lines
Diff to previous 1.70 (colored)
Uses termcap, not ncurses.
Revision 1.70 / (download) - annotate - [select for diffs], Sat Jul 9 06:38:33 2016 UTC (6 years, 8 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2016Q4-base,
pkgsrc-2016Q4,
pkgsrc-2016Q3-base,
pkgsrc-2016Q3
Changes since 1.69: +2 -1
lines
Diff to previous 1.69 (colored)
Bump PKGREVISION for perl-5.24.0 for everything mentioning perl.
Revision 1.69 / (download) - annotate - [select for diffs], Sun Jul 3 12:05:29 2016 UTC (6 years, 8 months ago) by wiz
Branch: MAIN
Changes since 1.68: +2 -3
lines
Diff to previous 1.68 (colored)
Updated pari to 2.7.6. Done for version 2.7.6 (released 20/06/2016): [last column crossreferences current development release 2.8.0] Fixed 1- [from 2.7.5] O(1) == O(x) returned 0 [#1765] 2- matsolve(a,b) and a^(-1) gave wrong results [or SEGV] when t_MAT [F86] a was not square and a,b "modular" (F2m,Flm,FpM,FqM,F2xqM,FlxqM) same for x^(-1) [#1666] 3- e=ellinit("11a1"); ellztopoint(e,3*e.omega[1]/5)[2] wrong [#1683] [F97] 4- K.codiff incorrect if [K:Q] > 2 [F130] 5- nfrootsof1(polcyclo(85)) -> 85 instead of 170 [#1766] [F133] 6- at \p19, polroots((x+1)^2*(x-1)^7*(x^2-x+1)^5*1.0)-> SEGV [#1767] [F134] BA 7- ellsea returned the trace instead of the cardinal as documented. [F135] BA 8- ellsea(,,1) could return a wrong result [#1768] [F136] MC 9- memory leak in pari_close: sopath not freed [F138] 10- isprimepower(30011^(3*17)) returned 0 [F141] BA 11- [mpi] interrupt/alarm could cause a crash [F143] BA 12- [mpi] relinking empty t_LIST caused a crash [F144] BA 13- my(s=1,a=0);forstep(i=1,20,s,s++;a+=i);a -> wrong result [F146] 14- sqrt(0) -> loss of accuracy (sqrtn was correct) [F148] 15- K = bnrinit(bnfinit(y^2-5),[1,[1,1]]); bnrdisc(K) ->wrong [#1804] [F152] 16- ellztopoint(ellinit([-1,0]), I) -> wrong result [#1800] [F153]
Revision 1.67.2.1 / (download) - annotate - [select for diffs], Mon May 23 04:58:36 2016 UTC (6 years, 10 months ago) by bsiegert
Branch: pkgsrc-2016Q1
Changes since 1.67: +2 -1
lines
Diff to previous 1.67 (colored) next main 1.68 (colored)
Pullup ticket #4993 - requested by joerg math/pari: build fix Revisions pulled up: - math/pari/Makefile 1.68 - math/pari/distinfo 1.25 - math/pari/patches/patch-config_Makefile.SH 1.2 --- Module Name: pkgsrc Committed By: joerg Date: Sat May 7 10:03:25 UTC 2016 Modified Files: pkgsrc/math/pari: Makefile distinfo pkgsrc/math/pari/patches: patch-config_Makefile.SH Log Message: Fix gp linking to not include the temporary DESTDIR. Bump revision.
Revision 1.68 / (download) - annotate - [select for diffs], Sat May 7 10:03:25 2016 UTC (6 years, 10 months ago) by joerg
Branch: MAIN
CVS Tags: pkgsrc-2016Q2-base,
pkgsrc-2016Q2
Changes since 1.67: +2 -1
lines
Diff to previous 1.67 (colored)
Fix gp linking to not include the temporary DESTDIR. Bump revision.
Revision 1.67 / (download) - annotate - [select for diffs], Thu Mar 3 13:28:22 2016 UTC (7 years ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2016Q1-base
Branch point for: pkgsrc-2016Q1
Changes since 1.66: +7 -4
lines
Diff to previous 1.66 (colored)
Update pari to 2.7.5. Bug numbers refer to the BTS at http://pari.math.u-bordeaux.fr/Bugs/ Done for version 2.7.5 (released 09/11/2015): [last column crossreferences current development release 2.8.0] Fixed 1- forprime engine could skip (fast) sieve in favour of (slow) nextprime [#1711] [F113] 2- 0^[1] -> domain error [#1713] [F114] 3- memory leaks (clones) in ellchangecurve [#1716] [F115] 4- zeta inaccurate around 0 [#1714] [F116] 5- bnrrootnumber did not support the trivial character [0,..,0] [F118] 6- default(log,1) when logfile is write-protected later lead to SEGV [F119] BA 7- 2-adic gamma function: fix accuracy loss [F120] 8- A==A -> 0 for A a t_SER of huge accuracy (so that A-A overflows valuation) [#1734] [F121] XR 9- P=Pol([1,-2,12,-12,-181,-4,-6899,9780,6360,702,-45]); for(i=1,10000,setrand(i);nfdisc(P)) -> crash [#1735] [F122] 10- select(x->x,Vecsmall([1,2,3]),1) -> crash [#1737] [F123] BA 11- [libpari] RgV_to_RgX_reverse did not work if v[1] or v[2] was 0 [F125] 12- bnfinit could fail at low precision [#1736] [F126] 13- Rg_to_ff: incorrect type in zk_to_ff [#1755] [F127] BA 14- nfsubfields could fail [#1758] [F128] 15- rare SEGV in ArtinNumber [#1759] [F129] Done for version 2.7.4 (released 19/06/2015): [last column crossreferences current development release 2.8.0] Fixed 1- divisors([2,1]) -> SEGV [#1664] [F84] 2- acos([Pol(1)]) -> GC bug [#1663] [F85] 3- primes([1,Pol(2)]) -> SEGV [#1668] [F87] 4- buffer overflow after default(format,"f.precision") [F95] 5- qfminim(A, 0, ...) -> stack overflow [#1682] [F97] 6- div_scal_rfrac could create an invalid t_POL [#1651] [F99] 7- polroots(t_POL with leading coeff = 0) -> fp exception [#1690] [F100] 8- \r cannot deal with very long filenames [#1616] [F101] 9- rnfisabelian(nf, non monic t_POL) -> SEGV [#1693] [F102] 10- possibly incorrect result in nfdisc(T,listP) [F104] 11- wrong dim(Ker) returned by ZM_pivot => SEGV in Z-linear algebra routines. E.g. setrand(1);quadclassunit(-612556842419) [#1700] [F105] 12- moebius(factor(18)) -> 1 instead of 0 [#1702] [F106] 13- ispower(-167^10) => domain error [#1703] [F107] 14- ispowerful(factor(0)) != ispowerful(0) [F108] 15- expm1(2*I) => wrong result [F109] 16- gamma(1+a*x+O(x^2)) => error [#1707] [F110] 17- printsep() printed its argument in random format instead of f_RAW [F111] 18- nfdisc(x^10 - 29080*x^5 - 25772600) -> oo loop [#1710] [F112] Added ED 1- mingw64 support [A111] Done for version 2.7.3 (released 18/02/2015): [last column crossreferences current development release 2.8.0] Fixed 1- [from 2.7.2] ??bnrL1 and ??ellL1 did not work anymore 2- thue(f^e*g, ...), e even, (f,g)=1 missed solutions such that f<0 [F22] XR 3- bnrL1(bnrinit(bnfinit(x^2-168),[6,[1,1]],1)) -> bug in ArtinNumber [F55] 4- nfisincl(t_POL, t_POL) could lead to wrong negative results [F58] 5- polresultant(1+x*z^2,1+y*z^4,z) -> GC error [#1614] [F59] BA 6- ellcard over non-prime fields could return wrong results [F60] 7- [libpari] FpX_roots could produce GC errors [#1618] [F61] 8- weber(1+I) was missing its imaginary part [F62] 9- (1+I)*(1+1/2*I) => wrong result (type errors) [#1619] [F63] 10- contfracpnqn([a]) => [1,a;0,1] instead of [a,1;1,0] [F64] 11- primes([2^50, 2^50+200000]) => stack overflow [F65] 12- issquare((x+1/2)^2,&z); z => 1.0*x+0.5 instead of x+1/2 [F66] 13- possibly missing roots in nfroots (when using Trager) [F68] 14- quadray(bnf, ideal) did not work [F69] 15- thue(-14*x^3 + 10*x^2 + 63*x - 5,1) -> "short continued fraction" [F70] 16- thue(29*x^3+130*x^2-35*x-48,1) -> "round error" bug [F71] 17- T=thueinit(10*x^3+6*x^2-41*x+8,1); thue(T,8) => SEGV [#1630] [F72] 18- ellrootno(e,p = 2 or 3) when e not minimal at p => random result [F73] 19- agm(1,2+O(5)) -> SEGV [#1645] [F76] BA 20- [cygwin64] ellap(ellinit([0,0,1,-1,0]),10007) was broken [F77] 21- primes([-5,5]) -> [5] (spurious absolute values) [F78] 22- matqr([;]) -> crash [F79] 23- Fp_rem_mBarrett could return a non-normalized result [F80] p=436^56-35;Mod(271,p)^((p-1)/2) -> p+1 24- plotcopy would corrupt "string" objects (ROt_ST) [F81] BA 25- [GP] default arguments to GP functions could cause corruption [F82] VBr26- [darwin] remove obsolete linker options that cause crashes [#1623] [F83] Done for version 2.7.2 (released 19/09/2014): [last column crossreferences current development release 2.8.0] Fixed 1- gaffsg(0, t_PADIC): wrong valuation [F21] 2- (t_INTMOD with word-sized modulus)^(huge negative power) [#1584] [F24] 3- (gp -p N) or (primelimit=N in gprc_ for N >= 436273290 resulted in an incorrect primetable. N.B. Such commands are now useless: needed primes are produced dynamically anyway. [F25] 4- monomial(exact zero, d, v) returned an invalid t_POL / t_RFRAC [F26] 5- 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] [F27] 6- factor((3+4*I)/25) -> factor 2+I had 0 exponent [#1586] [F29] BA 7- iferr() could crash if some component of the t_ERROR were clones. [F31] 8- nffactor() could overflow the stack when default accuracy too low [F32] BA 9- obsolete use of E=[a1,a2,a3,a4,a6] in ellmul crashed [#1589] [F33] 10- incorrect rounding in mulrr/divrr for one-word precision reals [F34] BA 11- multiif did not handle correctly return() in conditions [#1590] [F35] 12- [0..5] -> [0,0,0,0,0] on some architectures [F36] 13- is_gener_Fp could return wrong results [F37] 14- Fq_sqrtn(t_INT,..,&zeta) could return a wrong root of 1 [F38] 15- bnfinit: SEGV due to precision issues [#1592] [F39] 16- zm_zc_mul only worked for square zm matrices [F40] 17- genus2red(0,27*x^5+97*x^4+118*x^3+60*x^2+13*x+1,3) -> bug [#1596] [F41] 18- [gphelp] oo loop when $COLUMNS too small [#1594] [F42] 19- genus2red(x,-x^6-3*x^4-10*x^2-1,3) -> impossible inverse [#1597] [F43] 20- factoru(1) returned a t_MAT instead of the expected "matsmall" [F44] 21- FpM_charpoly wrong in small characteristic [#1602] [F45] 22- when compatible = 3; series() used a random precision [F50] 23- genus2red(0,6*x^6+5*x^4+x^2+1,7) -> impossible inverse [#1597] [F51] 24- isprime() could crash on large input [#1604] [F52] 25- genus2red(x^3+1,1) -> type error [#1597] [F53] 26- gphelp did not handle === correctly [#1603] [F54] 27- FpXY_evaly() wrong when evaluating at 0 [F56] 28- [mingw] gp could crash at start up [#1607] [F57] Done for version 2.7.1 (released 16/05/2014): [last column crossreferences current development release 2.8.0] Fixed 1- make install fails on OS/X: ln -s libpari.dylib libpari.dylib fails [F1] 2- Q_pvalrem(t_FRAC) => wrong result [F2] 3- [] == 0 but []~ != 0 (now []~ == 0 as well) [#1560] [F3] BA 4- test-kernel did not work when using --mt=pthread [F4] BA 5- ellheegner was using too much memory in some case [F5] BA 6- ellap can overflow on 32-bit machine [#1558] (minimal fix) [F6] 7- nfhilbert(K,x,y, P above 2) could give wrong results [#1561] [F7] 8- gcd(1/2, 1+I*1.) -> SEGV [#1563] [F10] 9- mathnf(t_VEC) could corrupt input (change sign) [F11] 10- [libpari] RgM_transmul did not work [F12] 11- [libpari] Fq_issquare didn't support T=NULL [F13] 12- [libpari] nfpow_u didn't handle non-integral rational numbers [F14] 13- eint1(0) -> stack overflow [#1568] [F15] 14- nfroots(, t_POL with leading coeff -1) could miss solutions [F19] 15- precprime(1) -> invalid t_INT [#1576] [F20]
Revision 1.66 / (download) - annotate - [select for diffs], Tue Aug 18 07:31:12 2015 UTC (7 years, 7 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2015Q4-base,
pkgsrc-2015Q4,
pkgsrc-2015Q3-base,
pkgsrc-2015Q3
Changes since 1.65: +2 -2
lines
Diff to previous 1.65 (colored)
Bump all packages that depend on curses.bui* or terminfo.bui* since they might incur ncurses dependencies on some platforms, and ncurses just bumped its shlib. Some packages were bumped twice now, sorry for that.
Revision 1.65 / (download) - annotate - [select for diffs], Mon Aug 17 17:11:25 2015 UTC (7 years, 7 months ago) by wiz
Branch: MAIN
Changes since 1.64: +2 -2
lines
Diff to previous 1.64 (colored)
Bump PKGREVISION for ncurses shlib bump.
Revision 1.64 / (download) - annotate - [select for diffs], Fri Jun 12 10:50:31 2015 UTC (7 years, 9 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2015Q2-base,
pkgsrc-2015Q2
Changes since 1.63: +2 -2
lines
Diff to previous 1.63 (colored)
Recursive PKGREVISION bump for all packages mentioning 'perl', having a PKGNAME of p5-*, or depending such a package, for perl-5.22.0.
Revision 1.63 / (download) - annotate - [select for diffs], Sat Apr 25 14:23:30 2015 UTC (7 years, 11 months ago) by tnn
Branch: MAIN
Changes since 1.62: +2 -2
lines
Diff to previous 1.62 (colored)
Recursive revbump following MesaLib update, categories g through n.
Revision 1.62 / (download) - annotate - [select for diffs], Fri Jan 23 15:07:53 2015 UTC (8 years, 2 months ago) by joerg
Branch: MAIN
CVS Tags: pkgsrc-2015Q1-base,
pkgsrc-2015Q1
Changes since 1.61: +2 -2
lines
Diff to previous 1.61 (colored)
Rename private strtoi function. Bump revision.
Revision 1.61 / (download) - annotate - [select for diffs], Tue Sep 23 09:08:21 2014 UTC (8 years, 6 months ago) by jperkin
Branch: MAIN
CVS Tags: pkgsrc-2014Q4-base,
pkgsrc-2014Q4,
pkgsrc-2014Q3-base,
pkgsrc-2014Q3
Changes since 1.60: +7 -1
lines
Diff to previous 1.60 (colored)
Remove TOOLS_DIR references from the generated pari.cfg.
Revision 1.60 / (download) - annotate - [select for diffs], Thu May 29 23:36:56 2014 UTC (8 years, 10 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2014Q2-base,
pkgsrc-2014Q2
Changes since 1.59: +2 -2
lines
Diff to previous 1.59 (colored)
Bump for perl-5.20.0. Do it for all packages that * mention perl, or * have a directory name starting with p5-*, or * depend on a package starting with p5- like last time, for 5.18, where this didn't lead to complaints. Let me know if you have any this time.
Revision 1.59 / (download) - annotate - [select for diffs], Mon Jul 15 02:02:26 2013 UTC (9 years, 8 months ago) by ryoon
Branch: MAIN
CVS Tags: pkgsrc-2014Q1-base,
pkgsrc-2014Q1,
pkgsrc-2013Q4-base,
pkgsrc-2013Q4,
pkgsrc-2013Q3-base,
pkgsrc-2013Q3
Changes since 1.58: +2 -2
lines
Diff to previous 1.58 (colored)
* .include "../../devel/readline/buildlink3.mk" with USE_GNU_READLINE=yes are replaced with .include "../../devel/readline/buildlink3.mk", and USE_GNU_READLINE are removed, * .include "../../devel/readline/buildlink3.mk" without USE_GNU_READLINE are replaced with .include "../../mk/readline.buildlink3.mk".
Revision 1.58 / (download) - annotate - [select for diffs], Fri May 31 12:41:24 2013 UTC (9 years, 10 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2013Q2-base,
pkgsrc-2013Q2
Changes since 1.57: +2 -2
lines
Diff to previous 1.57 (colored)
Bump all packages for perl-5.18, that a) refer 'perl' in their Makefile, or b) have a directory name of p5-*, or c) have any dependency on any p5-* package Like last time, where this caused no complaints.
Revision 1.57 / (download) - annotate - [select for diffs], Sat Feb 16 11:23:08 2013 UTC (10 years, 1 month ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2013Q1-base,
pkgsrc-2013Q1
Changes since 1.56: +2 -2
lines
Diff to previous 1.56 (colored)
Recursive bump for png-1.6.
Revision 1.56 / (download) - annotate - [select for diffs], Sat Jan 26 21:38:11 2013 UTC (10 years, 2 months ago) by adam
Branch: MAIN
Changes since 1.55: +2 -2
lines
Diff to previous 1.55 (colored)
Revbump after graphics/jpeg and textproc/icu
Revision 1.55 / (download) - annotate - [select for diffs], Wed Nov 21 00:47:52 2012 UTC (10 years, 4 months ago) by gdt
Branch: MAIN
CVS Tags: pkgsrc-2012Q4-base,
pkgsrc-2012Q4
Changes since 1.54: +2 -2
lines
Diff to previous 1.54 (colored)
Switch to fltk13. This is part of deprecating fltk 1.1. (Note that the fltk option is off by default, so few will care.)
Revision 1.54 / (download) - annotate - [select for diffs], Tue Nov 6 02:18:37 2012 UTC (10 years, 4 months ago) by gdt
Branch: MAIN
Changes since 1.53: +2 -2
lines
Diff to previous 1.53 (colored)
Don't include x11 in PKG_SUGGESTED_OPTIONS. This change makes pari, by default, not depend on fltk. pari is an indirect dependency of the perl module system, and thus should be minimal.
Revision 1.53 / (download) - annotate - [select for diffs], Wed Oct 3 21:56:40 2012 UTC (10 years, 5 months ago) by wiz
Branch: MAIN
Changes since 1.52: +2 -2
lines
Diff to previous 1.52 (colored)
Bump all packages that use perl, or depend on a p5-* package, or are called p5-*. I hope that's all of them.
Revision 1.52 / (download) - annotate - [select for diffs], Tue Sep 11 23:04:29 2012 UTC (10 years, 6 months ago) by asau
Branch: MAIN
CVS Tags: pkgsrc-2012Q3-base,
pkgsrc-2012Q3
Changes since 1.51: +1 -3
lines
Diff to previous 1.51 (colored)
"user-destdir" is default these days
Revision 1.51 / (download) - annotate - [select for diffs], Fri Mar 18 15:00:01 2011 UTC (12 years ago) by adam
Branch: MAIN
CVS Tags: pkgsrc-2012Q2-base,
pkgsrc-2012Q2,
pkgsrc-2012Q1-base,
pkgsrc-2012Q1,
pkgsrc-2011Q4-base,
pkgsrc-2011Q4,
pkgsrc-2011Q3-base,
pkgsrc-2011Q3,
pkgsrc-2011Q2-base,
pkgsrc-2011Q2,
pkgsrc-2011Q1-base,
pkgsrc-2011Q1
Changes since 1.50: +9 -3
lines
Diff to previous 1.50 (colored)
Pass CFLAGS to configure scripts, fixing problems on Mac OS X; clean up some pkglint issues.
Revision 1.50 / (download) - annotate - [select for diffs], Thu Jan 13 13:53:29 2011 UTC (12 years, 2 months ago) by wiz
Branch: MAIN
Changes since 1.49: +2 -2
lines
Diff to previous 1.49 (colored)
png shlib name changed for png>=1.5.0, so bump PKGREVISIONs.
Revision 1.49 / (download) - annotate - [select for diffs], Fri Oct 1 20:50:55 2010 UTC (12 years, 5 months ago) by minskim
Branch: MAIN
CVS Tags: pkgsrc-2010Q4-base,
pkgsrc-2010Q4,
pkgsrc-2010Q3-base,
pkgsrc-2010Q3
Changes since 1.48: +2 -2
lines
Diff to previous 1.48 (colored)
Reduce TeX dependencies. math/pari does not need the entire set of teTeX packages. Rather, pdftex and a few font packages suffice to build its documentation.
Revision 1.48 / (download) - annotate - [select for diffs], Wed Mar 24 19:43:27 2010 UTC (13 years ago) by asau
Branch: MAIN
CVS Tags: pkgsrc-2010Q2-base,
pkgsrc-2010Q2,
pkgsrc-2010Q1-base,
pkgsrc-2010Q1
Changes since 1.47: +2 -2
lines
Diff to previous 1.47 (colored)
Recursive revision bump for GMP update.
Revision 1.47 / (download) - annotate - [select for diffs], Sat Mar 13 22:16:34 2010 UTC (13 years ago) by schmonz
Branch: MAIN
Changes since 1.46: +5 -10
lines
Diff to previous 1.46 (colored)
Add a "doc" option (on by default) to control whether the documentation is rendered and installed. Disabling the option is helpful e.g. for web servers supporting OpenID logins, where X and TeX aren't present. Bump PKGREVISION.
Revision 1.46 / (download) - annotate - [select for diffs], Fri Feb 19 18:16:42 2010 UTC (13 years, 1 month ago) by schmonz
Branch: MAIN
Changes since 1.45: +2 -2
lines
Diff to previous 1.45 (colored)
Default x11 option to on (should have been done this way in previous). Bump PKGREVISION.
Revision 1.45 / (download) - annotate - [select for diffs], Fri Feb 19 08:33:28 2010 UTC (13 years, 1 month ago) by schmonz
Branch: MAIN
Changes since 1.44: +2 -8
lines
Diff to previous 1.44 (colored)
Make x11 support optional, default off. Bump PKGREVISION.
Revision 1.44 / (download) - annotate - [select for diffs], Fri Feb 12 18:18:29 2010 UTC (13 years, 1 month ago) by sno
Branch: MAIN
Changes since 1.43: +2 -1
lines
Diff to previous 1.43 (colored)
Updating math/pari from 2.3.5 to 2.3.5nb1 - Math::Pari requires one more function declaration from src/language/anal.h (moved into src/headers/paripriv.h, too)
Revision 1.43 / (download) - annotate - [select for diffs], Sat Feb 6 10:37:06 2010 UTC (13 years, 1 month ago) by sno
Branch: MAIN
Changes since 1.42: +20 -10
lines
Diff to previous 1.42 (colored)
Updating math/pari from 2.1.6nb3 to 2.3.5 (newer than PR pkg/38116) pkgsrc changes: - Adding license (GPLv2) - Adding X11 and GMP support (latter via option) - Adding patches to support math/p5-Math-Pari can be build without rebuilding pari again Upstream changes: * Primarily a lot of bug fixes * Plotting API reworked * More targets are supported
Revision 1.42 / (download) - annotate - [select for diffs], Wed May 20 00:58:22 2009 UTC (13 years, 10 months ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2009Q4-base,
pkgsrc-2009Q4,
pkgsrc-2009Q3-base,
pkgsrc-2009Q3,
pkgsrc-2009Q2-base,
pkgsrc-2009Q2
Changes since 1.41: +2 -2
lines
Diff to previous 1.41 (colored)
Recursive ABI depends update and PKGREVISION bump for readline-6.0 shlib major change. Reported by Robert Elz in PR 41345.
Revision 1.41 / (download) - annotate - [select for diffs], Wed Feb 25 03:33:03 2009 UTC (14 years, 1 month ago) by minskim
Branch: MAIN
CVS Tags: pkgsrc-2009Q1-base,
pkgsrc-2009Q1
Changes since 1.40: +3 -1
lines
Diff to previous 1.40 (colored)
Let pari depend on dvipsk because teTeX-bin no longer provides dvips.
Revision 1.40 / (download) - annotate - [select for diffs], Thu Jun 12 02:14:36 2008 UTC (14 years, 9 months ago) by joerg
Branch: MAIN
CVS Tags: pkgsrc-2008Q4-base,
pkgsrc-2008Q4,
pkgsrc-2008Q3-base,
pkgsrc-2008Q3,
pkgsrc-2008Q2-base,
pkgsrc-2008Q2,
cwrapper,
cube-native-xorg-base,
cube-native-xorg
Changes since 1.39: +3 -1
lines
Diff to previous 1.39 (colored)
Add DESTDIR support.
Revision 1.39 / (download) - annotate - [select for diffs], Tue Jan 23 17:59:42 2007 UTC (16 years, 2 months ago) by joerg
Branch: MAIN
CVS Tags: pkgsrc-2008Q1-base,
pkgsrc-2008Q1,
pkgsrc-2007Q4-base,
pkgsrc-2007Q4,
pkgsrc-2007Q3-base,
pkgsrc-2007Q3,
pkgsrc-2007Q2-base,
pkgsrc-2007Q2,
pkgsrc-2007Q1-base,
pkgsrc-2007Q1
Changes since 1.38: +2 -2
lines
Diff to previous 1.38 (colored)
Modular Xorg support.
Revision 1.38 / (download) - annotate - [select for diffs], Tue Sep 19 22:57:18 2006 UTC (16 years, 6 months ago) by joerg
Branch: MAIN
CVS Tags: pkgsrc-2006Q4-base,
pkgsrc-2006Q4,
pkgsrc-2006Q3-base,
pkgsrc-2006Q3
Changes since 1.37: +2 -2
lines
Diff to previous 1.37 (colored)
Fix X11 linkage. Bump revision. From PR 34563.
Revision 1.37 / (download) - annotate - [select for diffs], Wed Sep 6 09:44:57 2006 UTC (16 years, 6 months ago) by rillig
Branch: MAIN
Changes since 1.36: +3 -1
lines
Diff to previous 1.36 (colored)
Fixed the build error on NetBSD.
Revision 1.36 / (download) - annotate - [select for diffs], Thu Aug 10 03:21:39 2006 UTC (16 years, 7 months ago) by minskim
Branch: MAIN
Changes since 1.35: +2 -2
lines
Diff to previous 1.35 (colored)
Remove teTeX2 from TEX_ACCEPTED, because the teTeX2 packages will be removed shortly.
Revision 1.35 / (download) - annotate - [select for diffs], Sat May 13 03:44:23 2006 UTC (16 years, 10 months ago) by minskim
Branch: MAIN
CVS Tags: pkgsrc-2006Q2-base,
pkgsrc-2006Q2
Changes since 1.34: +2 -2
lines
Diff to previous 1.34 (colored)
Remove references to teTeX1.
Revision 1.34 / (download) - annotate - [select for diffs], Sat Mar 4 21:30:08 2006 UTC (17 years ago) by jlam
Branch: MAIN
CVS Tags: pkgsrc-2006Q1-base,
pkgsrc-2006Q1
Changes since 1.33: +2 -2
lines
Diff to previous 1.33 (colored)
Point MAINTAINER to pkgsrc-users@NetBSD.org in the case where no developer is officially maintaining the package. The rationale for changing this from "tech-pkg" to "pkgsrc-users" is that it implies that any user can try to maintain the package (by submitting patches to the mailing list). Since the folks most likely to care about the package are the folks that want to use it or are already using it, this would leverage the energy of users who aren't developers.
Revision 1.33 / (download) - annotate - [select for diffs], Sun Feb 5 23:10:03 2006 UTC (17 years, 1 month ago) by joerg
Branch: MAIN
Changes since 1.32: +2 -1
lines
Diff to previous 1.32 (colored)
Recursive revision bump / recommended bump for gettext ABI change.
Revision 1.32 / (download) - annotate - [select for diffs], Mon Dec 5 23:55:12 2005 UTC (17 years, 3 months ago) by rillig
Branch: MAIN
CVS Tags: pkgsrc-2005Q4-base,
pkgsrc-2005Q4
Changes since 1.31: +2 -2
lines
Diff to previous 1.31 (colored)
Ran "pkglint --autofix", which corrected some of the quoting issues in CONFIGURE_ARGS.
Revision 1.31 / (download) - annotate - [select for diffs], Mon Dec 5 20:50:37 2005 UTC (17 years, 3 months ago) by rillig
Branch: MAIN
Changes since 1.30: +4 -4
lines
Diff to previous 1.30 (colored)
Fixed pkglint warnings. The warnings are mostly quoting issues, for example MAKE_ENV+=FOO=${BAR} is changed to MAKE_ENV+=FOO=${BAR:Q}. Some other changes are outlined in http://mail-index.netbsd.org/tech-pkg/2005/12/02/0034.html
Revision 1.30 / (download) - annotate - [select for diffs], Fri Nov 11 18:50:24 2005 UTC (17 years, 4 months ago) by tonio
Branch: MAIN
Changes since 1.29: +3 -3
lines
Diff to previous 1.29 (colored)
Rename LATEX_ACCEPTED and LATEX_DEFAULT to TEX_ACCEPTED and TEX_DEFAULT It is more consistent with the tex.buildlink3.mk name. Also, if a package really needs latex, it just has to set TEX_ACCEPTED to latex distributions altough today, all TEX_ACCEPTED possibilities are latex distributions
Revision 1.29 / (download) - annotate - [select for diffs], Tue Nov 8 19:57:11 2005 UTC (17 years, 4 months ago) by tonio
Branch: MAIN
Changes since 1.28: +4 -2
lines
Diff to previous 1.28 (colored)
convert to use tex.buildlink3.mk set LATEX_DEPMETHOD=build
Revision 1.28 / (download) - annotate - [select for diffs], Thu Sep 8 08:39:59 2005 UTC (17 years, 6 months ago) by adam
Branch: MAIN
CVS Tags: pkgsrc-2005Q3-base,
pkgsrc-2005Q3
Changes since 1.27: +12 -13
lines
Diff to previous 1.27 (colored)
Changes 2.1.6: Fixed - src/kernel/sparcv8/MakeVar.SH missing from MANIFEST (hence from tarball) - stack corruption in matsnf() [ when GC occurs ] - incorrect result in gaffsg(s < 0, t_PADIC) - [hi-res plot: X-Windows] rescaling bug - [ix86 + gcc]: fix "invalid preprocessing token" Warning - removed hack in buchall() [ function called through unappropriate type (in init mode) to avoid inserting irrelevant arguments ]. Caused some compiler to produce incorrect code (SEGV). - typo in isabsolutepol(): SEGV in factorff for some t_POLs defined over the prime field - inconsistent error message when starting 'gp -p 436273000' - Configure support for GNU/Hurd
Revision 1.27 / (download) - annotate - [select for diffs], Sat Jul 16 19:10:39 2005 UTC (17 years, 8 months ago) by jlam
Branch: MAIN
Changes since 1.26: +2 -2
lines
Diff to previous 1.26 (colored)
Remove some unnecessarily strong dependencies on perl that resulted from including perl5/buildlink3.mk. These packages just need the Perl interpreter, and can just add "perl" to USE_TOOLS instead.
Revision 1.26 / (download) - annotate - [select for diffs], Fri Jul 8 22:10:45 2005 UTC (17 years, 8 months ago) by kristerw
Branch: MAIN
Changes since 1.25: +3 -2
lines
Diff to previous 1.25 (colored)
Prevent paths to the build directories from being included in the package. Bump PKGREVISION.
Revision 1.25 / (download) - annotate - [select for diffs], Wed Jun 1 18:03:03 2005 UTC (17 years, 10 months ago) by jlam
Branch: MAIN
CVS Tags: pkgsrc-2005Q2-base,
pkgsrc-2005Q2
Changes since 1.24: +2 -2
lines
Diff to previous 1.24 (colored)
Massive cleanup of buildlink3.mk and builtin.mk files in pkgsrc. Several changes are involved since they are all interrelated. These changes affect about 1000 files. The first major change is rewriting bsd.builtin.mk as well as all of the builtin.mk files to follow the new example in bsd.builtin.mk. The loop to include all of the builtin.mk files needed by the package is moved from bsd.builtin.mk and into bsd.buildlink3.mk. bsd.builtin.mk is now included by each of the individual builtin.mk files and provides some common logic for all of the builtin.mk files. Currently, this includes the computation for whether the native or pkgsrc version of the package is preferred. This causes USE_BUILTIN.* to be correctly set when one builtin.mk file includes another. The second major change is teach the builtin.mk files to consider files under ${LOCALBASE} to be from pkgsrc-controlled packages. Most of the builtin.mk files test for the presence of built-in software by checking for the existence of certain files, e.g. <pthread.h>, and we now assume that if that file is under ${LOCALBASE}, then it must be from pkgsrc. This modification is a nod toward LOCALBASE=/usr. The exceptions to this new check are the X11 distribution packages, which are handled specially as noted below. The third major change is providing builtin.mk and version.mk files for each of the X11 distribution packages in pkgsrc. The builtin.mk file can detect whether the native X11 distribution is the same as the one provided by pkgsrc, and the version.mk file computes the version of the X11 distribution package, whether it's built-in or not. The fourth major change is that the buildlink3.mk files for X11 packages that install parts which are part of X11 distribution packages, e.g. Xpm, Xcursor, etc., now use imake to query the X11 distribution for whether the software is already provided by the X11 distribution. This is more accurate than grepping for a symbol name in the imake config files. Using imake required sprinkling various builtin-imake.mk helper files into pkgsrc directories. These files are used as input to imake since imake can't use stdin for that purpose. The fifth major change is in how packages note that they use X11. Instead of setting USE_X11, package Makefiles should now include x11.buildlink3.mk instead. This causes the X11 package buildlink3 and builtin logic to be executed at the correct place for buildlink3.mk and builtin.mk files that previously set USE_X11, and fixes packages that relied on buildlink3.mk files to implicitly note that X11 is needed. Package buildlink3.mk should also include x11.buildlink3.mk when linking against the package libraries requires also linking against the X11 libraries. Where it was obvious, redundant inclusions of x11.buildlink3.mk have been removed.
Revision 1.24 / (download) - annotate - [select for diffs], Mon Apr 11 21:46:30 2005 UTC (17 years, 11 months ago) by tv
Branch: MAIN
Changes since 1.23: +1 -2
lines
Diff to previous 1.23 (colored)
Remove USE_BUILDLINK3 and NO_BUILDLINK; these are no longer used.
Revision 1.23 / (download) - annotate - [select for diffs], Sun Oct 3 00:12:57 2004 UTC (18 years, 5 months ago) by tv
Branch: MAIN
CVS Tags: pkgsrc-2005Q1-base,
pkgsrc-2005Q1,
pkgsrc-2004Q4-base,
pkgsrc-2004Q4
Changes since 1.22: +2 -2
lines
Diff to previous 1.22 (colored)
Libtool fix for PR pkg/26633, and other issues. Update libtool to 1.5.10 in the process. (More information on tech-pkg.) Bump PKGREVISION and BUILDLINK_DEPENDS of all packages using libtool and installing .la files. Bump PKGREVISION (only) of all packages depending directly on the above via a buildlink3 include.
Revision 1.22 / (download) - annotate - [select for diffs], Sun Apr 11 09:09:06 2004 UTC (18 years, 11 months ago) by snj
Branch: MAIN
CVS Tags: pkgsrc-2004Q3-base,
pkgsrc-2004Q3,
pkgsrc-2004Q2-base,
pkgsrc-2004Q2
Changes since 1.21: +5 -5
lines
Diff to previous 1.21 (colored)
Convert to buildlink3.
Revision 1.21 / (download) - annotate - [select for diffs], Fri Mar 26 02:27:45 2004 UTC (19 years ago) by wiz
Branch: MAIN
CVS Tags: pkgsrc-2004Q1-base,
pkgsrc-2004Q1
Changes since 1.20: +2 -2
lines
Diff to previous 1.20 (colored)
PKGREVISION bump after openssl-security-fix-update to 0.9.6m. Buildlink files: RECOMMENDED version changed to current version.
Revision 1.20 / (download) - annotate - [select for diffs], Sun Feb 22 02:19:50 2004 UTC (19 years, 1 month ago) by heinz
Branch: MAIN
Changes since 1.19: +5 -5
lines
Diff to previous 1.19 (colored)
Changed patch for "Configure" in order to accept LDFLAGS from the pkgsrc build environment. This made the package build with xpkgwedge. Bump revision to 2. HOMEPAGE and MASTERSITES have changed.
Revision 1.19 / (download) - annotate - [select for diffs], Tue Dec 30 17:27:31 2003 UTC (19 years, 3 months ago) by cjep
Branch: MAIN
Changes since 1.18: +2 -2
lines
Diff to previous 1.18 (colored)
Add trailing / to HOMEPAGEs
Revision 1.18 / (download) - annotate - [select for diffs], Sun Sep 28 09:13:58 2003 UTC (19 years, 6 months ago) by jlam
Branch: MAIN
CVS Tags: pkgsrc-2003Q4-base,
pkgsrc-2003Q4
Changes since 1.17: +2 -2
lines
Diff to previous 1.17 (colored)
Back out last change related to moving ncurses/buildlink2.mk to curses.buildlink2.mk. This was wrong because we _really_ do want to express that we want _n_curses when we include the buildlink2.mk file. We should have a better way to say that the NetBSD curses doesn't quite work well enough. In fact, it's far better to depend on ncurses by default, and exceptionally note when it's okay to use NetBSD curses for specific packages. We will look into this again in the future.
Revision 1.17 / (download) - annotate - [select for diffs], Sat Sep 27 17:07:37 2003 UTC (19 years, 6 months ago) by grant
Branch: MAIN
Changes since 1.16: +2 -2
lines
Diff to previous 1.16 (colored)
move ncurses/buildlink2.mk to mk/curses.buildlink2.mk, as it provides support for base system curses/ncurses as well as ncurses itself. suggested by wiz.
Revision 1.16 / (download) - annotate - [select for diffs], Mon Jul 21 16:57:14 2003 UTC (19 years, 8 months ago) by martti
Branch: MAIN
Changes since 1.15: +2 -2
lines
Diff to previous 1.15 (colored)
COMMENT should start with a capital letter.
Revision 1.15 / (download) - annotate - [select for diffs], Thu Jul 17 21:47:59 2003 UTC (19 years, 8 months ago) by grant
Branch: MAIN
Changes since 1.14: +2 -2
lines
Diff to previous 1.14 (colored)
s/netbsd.org/NetBSD.org/
Revision 1.14 / (download) - annotate - [select for diffs], Sun Jul 13 13:52:32 2003 UTC (19 years, 8 months ago) by wiz
Branch: MAIN
Changes since 1.13: +2 -1
lines
Diff to previous 1.13 (colored)
PKGREVISION bump for libiconv update.
Revision 1.13 / (download) - annotate - [select for diffs], Mon Jul 7 21:57:49 2003 UTC (19 years, 8 months ago) by jtb
Branch: MAIN
Changes since 1.12: +5 -5
lines
Diff to previous 1.12 (colored)
Update to pari-2.1.5. pkgsrc changes: * Build a shared libpari using libtool * convert to buildlink2 Changes in Pari itself: * a long list of bugfixes -- see CHANGES.
Revision 1.12 / (download) - annotate - [select for diffs], Mon Jun 2 01:18:25 2003 UTC (19 years, 10 months ago) by jschauma
Branch: MAIN
Changes since 1.11: +2 -2
lines
Diff to previous 1.11 (colored)
Use tech-pkg@ in favor of packages@ as MAINTAINER for orphaned packages. Should anybody feel like they could be the maintainer for any of thewe packages, please adjust.
Revision 1.11 / (download) - annotate - [select for diffs], Mon Sep 23 22:24:16 2002 UTC (20 years, 6 months ago) by jlam
Branch: MAIN
CVS Tags: netbsd-1-6-1-base,
netbsd-1-6-1
Changes since 1.10: +9 -13
lines
Diff to previous 1.10 (colored)
buildlink1 -> buildlink2
Revision 1.10 / (download) - annotate - [select for diffs], Wed Mar 13 17:37:24 2002 UTC (21 years ago) by fredb
Branch: MAIN
CVS Tags: pkgviews-base,
pkgviews,
netbsd-1-6-RELEASE-base,
netbsd-1-6,
netbsd-1-5-PATCH003,
buildlink2-base,
buildlink2
Changes since 1.9: +2 -1
lines
Diff to previous 1.9 (colored)
Give all packages which depend on "png" a version bump, and update all dependencies on packages depending on "png" which contain shared libraries, all for the (imminent) update to the "png" package. [List courtesy of John Darrow, courtesy of "bulk-build".]
Revision 1.9 / (download) - annotate - [select for diffs], Fri Nov 30 01:18:12 2001 UTC (21 years, 4 months ago) by wiz
Branch: MAIN
Changes since 1.8: +9 -8
lines
Diff to previous 1.8 (colored)
Buildlinkify.
Revision 1.8 / (download) - annotate - [select for diffs], Mon Jun 11 22:46:14 2001 UTC (21 years, 9 months ago) by jtb
Branch: MAIN
Changes since 1.7: +2 -1
lines
Diff to previous 1.7 (colored)
Add a build depends on emacs. Noted from John Darrow's i386 bulk build.
Revision 1.7 / (download) - annotate - [select for diffs], Sat May 19 17:31:05 2001 UTC (21 years, 10 months ago) by jtb
Branch: MAIN
Changes since 1.6: +10 -18
lines
Diff to previous 1.6 (colored)
Update to pari-2.1.1. Fixed 1- return() could forget objects on heap [F2] 2- polhensellift(x^3+x^2+2,[x^2,x+1],2) --> pols not coprime [F3] 3- Configure missed some shared libraries [e.g RedHat 7.0] [F4] 4- requests for precision of bnfinit(x) [ = Q ] could yield SEGV [F6] 5- compatible = 3 not taken into account when reading a file [F7] 6- lines > 0: output driver didn't reset properly after user output [F9] 7- nfdisc(x^5+2*x^4+3*x^3-3*x^2+122*x-1) --> impossible inverse [F10] 8- bug in gcc-2.95: SEGV on Linux (quicksqri) [F11] 9- addrfrac: could return a t_RFRAC whose denominator wasn't a t_POL[F12] 10- bnfcertify (zimmertbound): off by two error when reading bound [F13] BA 11- pbs in Fp_factor_irred (factoring over Fq a pol. defined over Fp)[F25] 12- typo in quadhilbertimag (SEGV for very large discriminants) [F28] BA 13- isprime(n < 2, 2 or 3) gave wrong result [F31] BA 14- nfgaloisconj(polcyclo(11)+1)--> oo loop [F35] nfgaloisconj(polcyclo(40))-->incorrect result IS 15- typo in squfof tuning on 64bit machines [F36] 16- van Hoeij's algorithm (factor(Z[X])): wrong bound in LLL_cmbf [F41] 17- rare SEGV in nfdisc [F44] 18- rare problem in isprincipal (large non Galois base field) [F56] --> wrong result (generators not required) or infinite loop. 19- build failed with readline-4.2 [F57] Changed 1- DOS distribution archives (GPM removed) [C1] XR 2- try more prime ideals in nfsqff [nffactor, modular part] [C4] 3- renamed library function gsize() to sizedigit() [pb with gtk] [C10] IK 4- let lisGEN() return NULL when EOF is met (was oo loop) [C12] 5- install the whole distribution (see ?12) + improved Configure [C17] Added 1- README.WIN, config/[arch-osname|locatesymbol], doc/tex2mail.1 [A1]
Revision 1.6 / (download) - annotate - [select for diffs], Fri May 4 17:14:08 2001 UTC (21 years, 10 months ago) by jtb
Branch: MAIN
CVS Tags: netbsd-1-5-PATCH001
Changes since 1.5: +7 -2
lines
Diff to previous 1.5 (colored)
* Install examples. * Install library as libpari.a. (Previously the package installed libpari.a.2.1 and created a symbolic link libpari.a). * Fix warning about O_RDONLY being redefined.
Revision 1.5 / (download) - annotate - [select for diffs], Thu May 3 22:16:51 2001 UTC (21 years, 11 months ago) by jtb
Branch: MAIN
Changes since 1.4: +10 -4
lines
Diff to previous 1.4 (colored)
Add defaults for all instances of EVAL_PREFIX.
Revision 1.4 / (download) - annotate - [select for diffs], Mon Apr 16 15:43:55 2001 UTC (21 years, 11 months ago) by jtb
Branch: MAIN
Changes since 1.3: +3 -3
lines
Diff to previous 1.3 (colored)
Use teTeX-[0-9]* in BUILD_DEPENDS as teTeX-* expands to a number of packages. pari.el only works for GNU Emacs.
Revision 1.3 / (download) - annotate - [select for diffs], Sat Apr 14 21:43:55 2001 UTC (21 years, 11 months ago) by jtb
Branch: MAIN
Changes since 1.2: +2 -2
lines
Diff to previous 1.2 (colored)
Change MAINTAINER section to packages@netbsd.org
Revision 1.2 / (download) - annotate - [select for diffs], Tue Mar 27 03:20:06 2001 UTC (22 years ago) by hubertf
Branch: MAIN
Changes since 1.1: +3 -3
lines
Diff to previous 1.1 (colored)
Change BUILD_DEPENDS semantics: first component is now a package name+version/pattern, no more executable/patchname/whatnot. While there, introduce BUILD_USES_MSGFMT as shorthand to pull in devel/gettext unless /usr/bin/msgfmt exists (i.e. on post-1.5 -current). Patch by Alistair Crooks <agc@netbsd.org>
Revision 1.1.1.1 / (download) - annotate - [select for diffs] (vendor branch), Wed Mar 7 20:57:48 2001 UTC (22 years ago) by jtb
Branch: TNF
CVS Tags: pkgsrc-base
Changes since 1.1: +0 -0
lines
Diff to previous 1.1 (colored)
Initial import of pari. PARI-GP is a package which is aimed at efficient computations in number theory, but also contains a large number of other useful functions. It is somewhat related to a Computer Algebra System, but is not really one since it treats symbolic expressions as mathematical entities such as matrices, polynomials, series, etc..., and not as expressions per se. However it is often much faster than other CAS, and contains a large number of specific functions not found elsewhere, essentially for use in number theory. This package can be used in an interactive shell (GP) or as a C/C++ library (PARI). It is free software, in the sense of freedom AND 'free of charge'.
Revision 1.1 / (download) - annotate - [select for diffs], Wed Mar 7 20:57:48 2001 UTC (22 years ago) by jtb
Branch: MAIN
Initial revision