summaryrefslogtreecommitdiff
path: root/math
AgeCommit message (Collapse)AuthorFilesLines
2016-09-20octave: suggest workaround for crashes in MESSAGEmaya1-0/+7
the default uses OpenGL and depending on the setup, it may lack certain features. see GNU Octave bug #44823: http://savannah.gnu.org/bugs/?44823
2016-09-20Add bl3.mk file for lbixion.wiz1-0/+14
2016-09-20+ libixion.wiz1-1/+2
2016-09-20Import libixion-0.12.1 as math/libixion.wiz4-0/+74
Ixion is a general purpose formula parser & interpreter that can calculate multiple named targets, or "cells". The goal of this project is to create a library for calculating the results of formula expressions stored in multiple named targets, or "cells". The cells can be referenced from each other, and the library takes care of resolving their dependencies automatically upon calculation. The caller can run the calculation routine either in a single-threaded mode, or a multi-threaded mode. The library also supports re-calculations where the contents of one or more cells have been modified since the last calculation, and a partial calculation of only the affected cells need to be calculated.
2016-09-18Fix the first two (glaring) build errors. There seem to be a lot more.dholland3-1/+33
2016-09-16Add py-lmfit 0.9.5prlw15-1/+104
A library for least-squares minimization and data fitting in Python, based on scipy.optimize.
2016-09-16Note error message from building with guile 2.0gdt1-1/+2
2016-09-15Updated libmatheval to 1.1.11.wiz5-27/+32
Set LICENSE. Still does not build with guile20, so leave it at 1.8. Version 1.1.11 * Fixed issue with linking Lex library. Version 1.1.10 * Fixed memory leak in evaluator_create function implementation. Version 1.1.9 * Fixed bug in math_step function implementation. * Updated manual.
2016-09-15After guile's and guile20's installation prefixes have changed, it's timewiz1-2/+2
to bump their dependencies (except those that were bumped in the last 24 hours already).
2016-09-13Update eigen3 to 3.2.9prlw14-49/+22
Eigen 3.2.9 Released on July 18, 2016 Changes since 3.2.8: * Main fixes and improvements: + Improve numerical robustness of JacobiSVD (backported from 3.3) + Bug 1017: prevents underflows in makeHouseholder + Fix numerical accuracy issue in the extraction of complex eigenvalue pairs in real generalized eigenvalue problems. + Fix support for vector.homogeneous().asDiagonal() + Bug 1238: fix SparseMatrix::sum() overload for un-compressed mode + Bug 1213: workaround gcc linking issue with anonymous enums. + Bug 1236: fix possible integer overflow in sparse-sparse product + Improve detection of identical matrices when applying a permutation (e.g., mat = perm * mat) + Fix usage of nesting type in blas_traits. In practice, this fixes compilation of expressions such as A*(A*A)^T + CMake: fixes support of Ninja generator + Add a StorageIndex typedef to sparse matrices and expressions to ease porting code to 3.3 (see http://eigen.tuxfamily.org/index.php?title=3.3#Index_typedef) + Bug 1200: make aligned_allocator c++11 compatible (backported from 3.3) + Bug 1182: improve generality of abs2 (backported from 3.3) + Bug 537: fix compilation of Quaternion with Apples's compiler + Bug 1176: allow products between compatible scalar types + Bug 1172: make valuePtr and innerIndexPtr properly return null for empty sparse matrices. + Bug 1170: skip calls to memcpy/memmove for empty inputs. * Others: + Bug 1242: fix comma initializer with empty matrices. + Improves support for MKL's PARDISO solver. + Fix a compilation issue with Pastix solver. + Add some missing explicit scalar conversions + Fix a compilation issue with matrix exponential (unsupported MatrixFunctions module). + Bug 734: fix a storage order issue in unsupported Spline module + Bug 1222: fix a compilation issue in AutoDiffScalar + Bug 1221: shutdown some GCC6's warnings. + Bug 1175: fix index type conversion warnings in sparse to dense conversion. Eigen 3.2.8 Released on February 16, 2016 Changes since 3.2.7: * Main fixes and improvements: + Make FullPivLU::solve use rank() instead of nonzeroPivots(). + Add EIGEN_MAPBASE_PLUGIN + Bug 1166: fix issue in matrix-vector products when the destination is not a vector at compile-time. + Bug 1100: Improve cmake/pkg-config support. + Bug 1113: fix name conflict with C99's "I". + Add missing delete operator overloads in EIGEN_MAKE_ALIGNED_OPERATOR_NEW + Fix (A*B).maxCoeff(i) and similar. + Workaround an ICE with VC2015 Update1 x64. + Bug 1156: fix several function declarations whose arguments were passed by value instead of being passed by reference + Bug 1164: fix std::list and std::deque specializations such that our aligned allocator is automatically activatived only when the user did not specified an allocator (or specified the default std::allocator). * Others: + Fix BLAS backend (aka MKL) for empty matrix products. + Bug 1134: fix JacobiSVD pre-allocation. + Bug 1111: fix infinite recursion in sparse-column-major.row(i).nonZeros() (it now produces a compilation error) + Bug 1106: workaround a compilation issue in Sparse module for msvc-icc combo + Bug 1153: remove the usage of __GXX_EXPERIMENTAL_CXX0X__ to detect C++11 support + Bug 1143: work-around gcc bug in COLAMD + Improve support for matrix products with empty factors. + Fix and clarify documentation of Transform wrt operator*(MatrixBase) + Add a matrix-free conjugate gradient example. + Fix cost computation in CwiseUnaryView (internal) + Remove custom unaligned loads for SSE. + Some warning fixes. + Several other documentation clarifications.
2016-09-11This package does in fact support python-3.x.wiz1-4/+1
2016-09-08Override zlib 1.2.5 check in configure, it is not required. Unbreaksjoerg1-2/+3
NetBSD 7.0 and earlier.
2016-09-08Update to lp_solve_5.5.2.3 and indicate a 64-bit platform for aarch64richard4-13/+39
Fix isnan() checks to declare main() returning 'int' and use floating argument to isnan() avoiding recent (gcc 5) compiler noise. Since last update: ../../.. version 5.5.2.1 - fixed a small error in new and improved MIP_stepOF function to find integer solutions. ../../.. version 5.5.2.2 - For integer models with semi-cont variables it happened sometimes that a message "fillbranches_BB: Inconsistent equal-valued bounds for ..." occured and that the semi-cont condition was not respected. - New functions added: get_accuracy to get the numeric accuracy after solve. - New functions added: set_break_numeric_accuracy, get_break_numeric_accuracy to let lp_solve return ACCURACYERROR instead of FEASIBLE when numerical accuracy if worse then the provided values. In the past, lp_solve only returned a non-optimal status in case of very severe numerical instability. Now it will return already ACCURACYERROR when it finds a relative inaccuracy of 5e-7 - When reading a model from the lp-format and important issues are detected such as already bounds on variables being overruled later with for example a bin keyword, this is now reported in the default verbose level such that this is seen easier. 08/05/16 version 5.5.2.3 - For some models with integer variables, lp_solve did not find the most optimal solution.
2016-09-08Limit to php70 and php71, php55 and php56 require php-stats 1.0.5.taca1-1/+3
2016-09-04Updated gsl to 2.2.1.wiz2-7/+7
* What is new in gsl-2.2.1: ** reverted gsl_linalg_cholesky_decomp to its previous behavior so it is backward compatible; new cholesky routine is gsl_linalg_cholesky_decomp1
2016-09-02Bump PKGREVISION for pc file fix.wiz1-1/+2
2016-09-02patch pkgconfig fileplunky2-1/+12
cflags was "-Iinclude/eigen3" which was clearly wrong, so add prefix
2016-09-01Updated gsl to 2.2.wiz3-8/+25
* What is new in gsl-2.2: ** updated gsl_linalg_cholesky_invert to use Level-2 BLAS and added function gsl_linalg_pcholesky_invert ** added function gsl_linalg_invtri for inverting triangular matrices ** fix GSL_EIGEN_SORT_VAL_{ASC,DESC} for nonsymmetric eigensystems (Victor Zverovich) ** added complete orthogonal decomposition routines (gsl_linalg_COD) ** bug fix where median calculation wasn't reset in gsl_rstat_reset(); added gsl_rstat_quantile_reset() function (reported by Pedro Donato) ** added multivariate Gaussian random distribution gsl_ran_multivariate_gaussian (Timothée Flutre) ** added functions to estimate the 1-norm reciprocal condition number for various matrix factorizations: * gsl_linalg_cholesky_rcond * gsl_linalg_QRPT_rcond ** added functions gsl_linalg_QRPT_{lssolve,lssolve2} to compute least squares solutions with the QRPT decomposition ** added function gsl_permute_matrix() ** added modified Cholesky factorization (gsl_linalg_mcholesky) to handle symmetric indefinite matrices ** added pivoted Cholesky factorization (gsl_linalg_pcholesky) for ill-conditioned matrices ** rewrote (real) Cholesky decomposition to use a Level-2 blas algorithm instead of Level-1. Flop count is about the same but the code is much simpler and easier to follow ** completely rewritten nonlinear least squares module, including support for large problems; the user may now control the linear solver used, the trust region updating strategy, and the scaling method. In addition, support has been added for the geodesic acceleration step (Transtrum 2011) which can speed up convergence on a wide class of problems. ** added gsl_rstat_rms() for root mean square ** optimized lmniel nonlinear least squares solver (bug #46369) ** improved precision in Bessel K0/K1 near x = 2 (Pavel Holoborodko, bug #47401) ** added support for compressed row storage sparse matrices (Alexis Tantet) ** bug fix in convergence check of hypergeometric 2F1 function (bug #45926) ** added gsl_multilarge_linear_lcurve() to compute the L-curve for large linear systems ** updated multilarge normal equations method to use new Cholesky scaling for better numerical stability ** added scaling to Cholesky routines to reduce the condition number prior to factorization
2016-08-28Remove unnecessary PLIST_SUBST and FILES_SUBST that are now providedwiz5-12/+6
by the infrastructure. Mark a couple more packages as not ready for python-3.x.
2016-08-26Fix pthread use.joerg1-1/+3
2016-08-24Add py-autogradmarkd1-1/+2
2016-08-24Add py-autograd 1.1.5markd4-0/+110
Autograd can automatically differentiate native Python and Numpy code. It can handle a large subset of Python's features, including loops, ifs, recursion and closures, and it can even take derivatives of derivatives of derivatives. It uses reverse-mode differentiation (a.k.a. backpropagation), which means it can efficiently take gradients of scalar-valued functions with respect to array-valued arguments. The main intended application is gradient-based optimization.
2016-08-23py-nose test dependency.wiz1-2/+4
2016-08-21Update gnome-calculator to 3.21.90prlw13-8/+9
Apart from translation updates, this is the same as the "stable" 3.20.2, but with history-view.ui and history-entry.ui now included in the tarball. Since glib fixed 673101 resource compiler dependency generation not working for generated files gnome-calculator will not compile without the missing files. Overview of changes in gnome-calculator 3.21.90 * Updated Hebrew translation (Yosef Or Boczko) * Added 'period' keypress when the delete key on the numpad is pressed. (Myridium) * Updated Spanish translation (Daniel Mustieles) * also in 3.20.2: lib: prevents segfault when elements of division to zero have null assigned tokens (fixes #769364) (Alberto Ruiz) * Add Language headers to po files (Piotr Drg) * Updated Swedish translation (Anders Jonsson) * Updated Friulian translation (Fabio Tomat) * Updated Indonesian translation (cherry picked from commit da3a093148c5f9340c6566fe35d5a38b5aa04e6b) (Andika Triwidada) * Updated Occitan translation (Cdric Valmary) Overview of changes in gnome-calculator 3.21.2 * Updated Norwegian bokml translation. (Kjartan Maraas) * Updated Friulian translation (Fabio Tomat) * Updated Friulian translation (Fabio Tomat) * Updated Friulian translation (Fabio Tomat) * Added Friulian translation (Fabio Tomat) * Distribute history-view.ui (Robert Ancell) * Distribute history-entry.ui (Robert Ancell) * Updated Occitan translation (Cdric Valmary)
2016-08-20+ py-noise.wiz1-1/+2
2016-08-20Import py-noise-1.2.2 as math/py-noise.wiz4-0/+51
Perlin noise is ubiquitous in modern CGI. Used for procedural texturing, animation, and enhancing realism, Perlin noise has been called the "salt" of procedural content. Perlin noise is a type of gradient noise, smoothly interpolating across a pseudo-random matrix of values. The noise library includes native-code implementations of Perlin "improved" noise and Perlin simplex noise. It also includes a fast implementation of Perlin noise in GLSL, for use in OpenGL shaders.
2016-08-19+ rangercheusov1-1/+2
2016-08-19Importing math/rangercheusov4-0/+37
Ranger is a fast implementation of random forest (Breiman 2001) or recursive partitioning, particularly suited for high dimensional data. Classification, regression, probability estimation and survival forests are supported. Classification and regression forests are implemented as in the original Random Forest (Breiman 2001), survival forests as in Random Survival Forests (Ishwaran et al. 2008). For probability estimation forests see Malley et al. (2012).
2016-08-19Update fftw{,f} to 3.3.5.wiz4-15/+14
FFTW 3.3.5: * New SIMD support: - Power8 VSX instructions in single and double precision. To use, add --enable-vsx to configure. - Support for AVX2 (256-bit FMA instructions). To use, add --enable-avx2 to configure. - Experimental support for AVX512 and KCVI. (--enable-avx512, --enable-kcvi) This code is expected to work but the FFTW maintainers do not have hardware to test it. - Support for AVX128/FMA (for some AMD machines) (--enable-avx128-fma) - Double precision Neon SIMD for aarch64. This code is expected to work but the FFTW maintainers do not have hardware to test it. - generic SIMD support using gcc vector intrinsics * Add fftw_make_planner_thread_safe() API * fix #18 (disable float128 for CUDACC) * fix #19: missing Fortran interface for fftwq_alloc_real * fix #21 (don't use float128 on Portland compilers, which pretend to be gcc) * fix: Avoid segfaults due to double free in MPI transpose * Special note for distribution maintainers: Although FFTW supports a zillion SIMD instruction sets, enabling them all at the same time is a bad idea, because it increases the planning time for minimal gain. We recommend that general-purpose x86 distributions only enable SSE2 and perhaps AVX. Users who care about the last ounce of performance should recompile FFTW themselves.
2016-08-19Updated py-scipy to 0.18.0.wiz3-24/+80
Test failures reported upstream. ========================== SciPy 0.18.0 Release Notes ========================== .. contents:: SciPy 0.18.0 is the culmination of 6 months of hard work. It contains many new features, numerous bug-fixes, improved test coverage and better documentation. There have been a number of deprecations and API changes in this release, which are documented below. All users are encouraged to upgrade to this release, as there are a large number of bug-fixes and optimizations. Moreover, our development attention will now shift to bug-fix releases on the 0.19.x branch, and on adding new features on the master branch. This release requires Python 2.7 or 3.4-3.5 and NumPy 1.7.1 or greater. Highlights of this release include: - A new ODE solver for two-point boundary value problems, `scipy.optimize.solve_bvp`. - A new class, `CubicSpline`, for cubic spline interpolation of data. - N-dimensional tensor product polynomials, `scipy.interpolate.NdPPoly`. - Spherical Voronoi diagrams, `scipy.spatial.SphericalVoronoi`. - Support for discrete-time linear systems, `scipy.signal.dlti`. New features ============ `scipy.integrate` improvements ------------------------------ A solver of two-point boundary value problems for ODE systems has been implemented in `scipy.integrate.solve_bvp`. The solver allows for non-separated boundary conditions, unknown parameters and certain singular terms. It finds a C1 continious solution using a fourth-order collocation algorithm. `scipy.interpolate` improvements -------------------------------- Cubic spline interpolation is now available via `scipy.interpolate.CubicSpline`. This class represents a piecewise cubic polynomial passing through given points and C2 continuous. It is represented in the standard polynomial basis on each segment. A representation of n-dimensional tensor product piecewise polynomials is available as the `scipy.interpolate.NdPPoly` class. Univariate piecewise polynomial classes, `PPoly` and `Bpoly`, can now be evaluated on periodic domains. Use ``extrapolate="periodic"`` keyword argument for this. `scipy.fftpack` improvements ---------------------------- `scipy.fftpack.next_fast_len` function computes the next "regular" number for FFTPACK. Padding the input to this length can give significant performance increase for `scipy.fftpack.fft`. `scipy.signal` improvements --------------------------- Resampling using polyphase filtering has been implemented in the function `scipy.signal.resample_poly`. This method upsamples a signal, applies a zero-phase low-pass FIR filter, and downsamples using `scipy.signal.upfirdn` (which is also new in 0.18.0). This method can be faster than FFT-based filtering provided by `scipy.signal.resample` for some signals. `scipy.signal.firls`, which constructs FIR filters using least-squares error minimization, was added. `scipy.signal.sosfiltfilt`, which does forward-backward filtering like `scipy.signal.filtfilt` but for second-order sections, was added. Discrete-time linear systems ~~~~~~~~~~~~~~~~~~~~~~~~~~~~ `scipy.signal.dlti` provides an implementation of discrete-time linear systems. Accordingly, the `StateSpace`, `TransferFunction` and `ZerosPolesGain` classes have learned a the new keyword, `dt`, which can be used to create discrete-time instances of the corresponding system representation. `scipy.sparse` improvements --------------------------- The functions `sum`, `max`, `mean`, `min`, `transpose`, and `reshape` in `scipy.sparse` have had their signatures augmented with additional arguments and functionality so as to improve compatibility with analogously defined functions in `numpy`. Sparse matrices now have a `count_nonzero` method, which counts the number of nonzero elements in the matrix. Unlike `getnnz()` and ``nnz`` propety, which return the number of stored entries (the length of the data attribute), this method counts the actual number of non-zero entries in data. `scipy.optimize` improvements ----------------------------- The implementation of Nelder-Mead minimization, `scipy.minimize(..., method="Nelder-Mead")`, obtained a new keyword, `initial_simplex`, which can be used to specify the initial simplex for the optimization process. Initial step size selection in CG and BFGS minimizers has been improved. We expect that this change will improve numeric stability of optimization in some cases. See pull request gh-5536 for details. Handling of infinite bounds in SLSQP optimization has been improved. We expect that this change will improve numeric stability of optimization in the some cases. See pull request gh-6024 for details. A large suite of global optimization benchmarks has been added to ``scipy/benchmarks/go_benchmark_functions``. See pull request gh-4191 for details. Nelder-Mead and Powell minimization will now only set defaults for maximum iterations or function evaluations if neither limit is set by the caller. In some cases with a slow converging function and only 1 limit set, the minimization may continue for longer than with previous versions and so is more likely to reach convergence. See issue gh-5966. `scipy.stats` improvements -------------------------- Trapezoidal distribution has been implemented as `scipy.stats.trapz`. Skew normal distribution has been implemented as `scipy.stats.skewnorm`. Burr type XII distribution has been implemented as `scipy.stats.burr12`. Three- and four-parameter kappa distributions have been implemented as `scipy.stats.kappa3` and `scipy.stats.kappa4`, respectively. New `scipy.stats.iqr` function computes the interquartile region of a distribution. Random matrices ~~~~~~~~~~~~~~~ `scipy.stats.special_ortho_group` and `scipy.stats.ortho_group` provide generators of random matrices in the SO(N) and O(N) groups, respectively. They generate matrices in the Haar distribution, the only uniform distribution on these group manifolds. `scipy.stats.random_correlation` provides a generator for random correlation matrices, given specified eigenvalues. `scipy.linalg` improvements --------------------------- `scipy.linalg.svd` gained a new keyword argument, ``lapack_driver``. Available drivers are ``gesdd`` (default) and ``gesvd``. `scipy.linalg.lapack.ilaver` returns the version of the LAPACK library SciPy links to. `scipy.spatial` improvements ---------------------------- Boolean distances, `scipy.spatial.pdist`, have been sped up. Improvements vary by the function and the input size. In many cases, one can expect a speed-up of x2--x10. New class `scipy.spatial.SphericalVoronoi` constructs Voronoi diagrams on the surface of a sphere. See pull request gh-5232 for details. `scipy.cluster` improvements ---------------------------- A new clustering algorithm, the nearest neighbor chain algorithm, has been implemented for `scipy.cluster.hierarchy.linkage`. As a result, one can expect a significant algorithmic improvement (:math:`O(N^2)` instead of :math:`O(N^3)`) for several linkage methods. `scipy.special` improvements ---------------------------- The new function `scipy.special.loggamma` computes the principal branch of the logarithm of the Gamma function. For real input, ``loggamma`` is compatible with `scipy.special.gammaln`. For complex input, it has more consistent behavior in the complex plane and should be preferred over ``gammaln``. Vectorized forms of spherical Bessel functions have been implemented as `scipy.special.spherical_jn`, `scipy.special.spherical_kn`, `scipy.special.spherical_in` and `scipy.special.spherical_yn`. They are recommended for use over ``sph_*`` functions, which are now deprecated. Several special functions have been extended to the complex domain and/or have seen domain/stability improvements. This includes `spence`, `digamma`, `log1p` and several others. Deprecated features =================== The cross-class properties of `lti` systems have been deprecated. The following properties/setters will raise a `DeprecationWarning`: Name - (accessing/setting raises warning) - (setting raises warning) * StateSpace - (`num`, `den`, `gain`) - (`zeros`, `poles`) * TransferFunction (`A`, `B`, `C`, `D`, `gain`) - (`zeros`, `poles`) * ZerosPolesGain (`A`, `B`, `C`, `D`, `num`, `den`) - () Spherical Bessel functions, ``sph_in``, ``sph_jn``, ``sph_kn``, ``sph_yn``, ``sph_jnyn`` and ``sph_inkn`` have been deprecated in favor of `scipy.special.spherical_jn` and ``spherical_kn``, ``spherical_yn``, ``spherical_in``. The following functions in `scipy.constants` are deprecated: ``C2K``, ``K2C``, ``C2F``, ``F2C``, ``F2K`` and ``K2F``. They are superceded by a new function `scipy.constants.convert_temperature` that can perform all those conversions plus to/from the Rankine temperature scale. Backwards incompatible changes ============================== `scipy.optimize` ---------------- The convergence criterion for ``optimize.bisect``, ``optimize.brentq``, ``optimize.brenth``, and ``optimize.ridder`` now works the same as ``numpy.allclose``. `scipy.ndimage` --------------- The offset in ``ndimage.iterpolation.affine_transform`` is now consistently added after the matrix is applied, independent of if the matrix is specified using a one-dimensional or a two-dimensional array. `scipy.stats` ------------- ``stats.ks_2samp`` used to return nonsensical values if the input was not real or contained nans. It now raises an exception for such inputs. Several deprecated methods of `scipy.stats` distributions have been removed: ``est_loc_scale``, ``vecfunc``, ``veccdf`` and ``vec_generic_moment``. Deprecated functions ``nanmean``, ``nanstd`` and ``nanmedian`` have been removed from `scipy.stats`. These functions were deprecated in scipy 0.15.0 in favor of their `numpy` equivalents. A bug in the ``rvs()`` method of the distributions in `scipy.stats` has been fixed. When arguments to ``rvs()`` were given that were shaped for broadcasting, in many cases the returned random samples were not random. A simple example of the problem is ``stats.norm.rvs(loc=np.zeros(10))``. Because of the bug, that call would return 10 identical values. The bug only affected code that relied on the broadcasting of the shape, location and scale parameters. The ``rvs()`` method also accepted some arguments that it should not have. There is a potential for backwards incompatibility in cases where ``rvs()`` accepted arguments that are not, in fact, compatible with broadcasting. An example is stats.gamma.rvs([2, 5, 10, 15], size=(2,2)) The shape of the first argument is not compatible with the requested size, but the function still returned an array with shape (2, 2). In scipy 0.18, that call generates a ``ValueError``. `scipy.io` ---------- `scipy.io.netcdf` masking now gives precedence to the ``_FillValue`` attribute over the ``missing_value`` attribute, if both are given. Also, data are only treated as missing if they match one of these attributes exactly: values that differ by roundoff from ``_FillValue`` or ``missing_value`` are no longer treated as missing values. `scipy.interpolate` ------------------- `scipy.interpolate.PiecewisePolynomial` class has been removed. It has been deprecated in scipy 0.14.0, and `scipy.interpolate.BPoly.from_derivatives` serves as a drop-in replacement. Other changes ============= Scipy now uses ``setuptools`` for its builds instead of plain distutils. This fixes usage of ``install_requires='scipy'`` in the ``setup.py`` files of projects that depend on Scipy (see Numpy issue gh-6551 for details). It potentially affects the way that build/install methods for Scipy itself behave though. Please report any unexpected behavior on the Scipy issue tracker. PR `#6240 <https://github.com/scipy/scipy/pull/6240>`__ changes the interpretation of the `maxfun` option in `L-BFGS-B` based routines in the `scipy.optimize` module. An `L-BFGS-B` search consists of multiple iterations, with each iteration consisting of one or more function evaluations. Whereas the old search strategy terminated immediately upon reaching `maxfun` function evaluations, the new strategy allows the current iteration to finish despite reaching `maxfun`. The bundled copy of Qhull in the `scipy.spatial` subpackage has been upgraded to version 2015.2. The bundled copy of ARPACK in the `scipy.sparse.linalg` subpackage has been upgraded to arpack-ng 3.3.0. The bundled copy of SuperLU in the `scipy.sparse` subpackage has been upgraded to version 5.1.1.
2016-08-19Switch to egg.mk.wiz2-9/+11
Fix PLIST for python-3.x.
2016-08-19Prefer egg.mk to distutils.mk. Clean up. Add missing dependency onwiz2-10/+16
py-sqlite3. Add missing test dependency on py-nose. Add comments with links to bug reports about test failures. Bump PKGREVISION for dependency change.
2016-08-18Add a patch to fix build with python-3.x where cpuinfo does not seemwiz4-5/+36
to provide flags. Fix parallel installation of different python-versions of this package. Bump PKGREVISION.
2016-08-18Remove URL from DESCR, it's HOMEPAGE.wiz1-1/+0
2016-08-18+ vowpal_wabbitcheusov1-1/+2
2016-08-18Import vowpal_wabbitcheusov4-0/+91
2016-08-16Use PYPKGVERSION in PLISTmaya1-4/+4
2016-08-16py-sympy: use python pkg version for man page in PLISTmaya1-2/+2
2016-08-16Update py-sympy to 1.0maya4-359/+286
Release Notes for 1.0 Major changes As a 1.0 release, there are some major changes, many of which are breaking. See also the "backwards compatibility breaks and deprecations" section below. mpmath is now a hard external dependency for SymPy. sympy.mpmath will no longer work (use import mpmath). See http://docs.sympy.org/latest/install.html#mpmath for more information on how to install mpmath. The galgebra Geometric Algebra module has been removed. The module is now maintained separately at https://github.com/brombo/galgebra. The new solveset function is a planned replacement for solve. solve is not yet deprecated, since solveset hasn't yet fully replicated all the functionality of solve. solveset offers an improved interface to solve. See http://docs.sympy.org/latest/modules/solvers/solveset.html for more information on solveset vs. solve. This will be the last version of SymPy to support Python 2.6 and 3.2. Both of these Python versions have reached end-of-life. Support for other Python versions will continue at least until they have reached end-of-life. Backwards compatibility breaks and deprecations In sympy.geometry, Line.equal() has been deprecated in favor of Line.equals(). The dup_inner_subresultants and dmp_inner_subresultants now only return 2 arguments instead of 3. Only those building their own routines from these very low-level functions need to be aware of this. This release doesn't include copy of the mpmath library, see PR #2192. Please see new installation instructions for SymPy. The release no longer includes the galgebra subumodule. This module is now maintained separately at https://github.com/brombo/galgebra. See PR #10046. ClassRegistry is deprecated. It's unlikely that anybody ever used it; it is scheduled for removal for the next version of SymPy after 1.0. sympy.C is deprecated and scheduled for removal after 1.0, too. For those users who followed some erroneous SymPy documentation and used C as in C.log, just import sympy and use sympy.log instead: this is compatible with SymPy before and after we remove C. Q.bounded has been deprecated. Use Q.finite instead. Q.infinity has been deprecated. Use Q.infinite instead. Q.infinitesimal has been deprecated. Use Q.zero instead. ask(Q.nonzero(non-real)) now returns False. Note that Q.nonzero is equivalent to ~Q.zero & Q.real. If you intend to find whether x is a non-zero number irrespective of the fact that x is real or not, you should use ask(~Q.zero(x)). x.is_nonzero now returns True iff x is real and has a non-zero value. If you intend to find whether x is a non-zero number irrespective of the fact that x is real or not, you should use fuzzy_not(x.is_zero). isprime(Float) now returns False. ask(Q.integer(Float)) now returns False. ask(Q.prime(Float)) now returns False. ask(Q.composite(Float)) now returns False. ask(Q.even(Float)) now returns False. ask(Q.odd(Float)) now returns False. New features The module sympy.series.ring_series has been updated. New methods for series inversion, expansion of hyperbolic and inverse functions, etc have been added. PR #9262 New module sympy.series.sequences for generating finite/infinite lazily evaluated lists. [PR #9435] The string representation function srepr() now displays the assumptions used to create a Symbol. For example, srepr(Symbol('x', real=True)) now returns the string "Symbol('x', real=True)" instead of merely "Symbol('x')". not_empty_in function added to util.py in calculus module which finds the domain for which the FiniteSet is not-empty for a given Union of Sets. [PR #9779] A new and fast method rs_series has been added for calculating series expansions. It can handle multivariate Puiseux series with symbolic coefficients. It is especially optimized for large series, with speedup over the older series method being in the range 20-1000 times. PR #9775 In [37]: %timeit rs_series(cos(a+b*a**QQ(3,2)), a, 10) 100 loops, best of 3: 5.59 ms per loop In [38]: %timeit cos(a+b*a**QQ(3,2)).series(a, 0, 10) 1 loops, best of 3: 997 ms per loop Complex Sets has been added here: sympy.sets.fancysets, use S.Complexes for singleton ComplexRegion class. PR #9463 GeometryEntity now subclasses from sets.Set, so sets.Intersection and sets.Union can be used with GeometryEntitys. For example Intersection(Line((-1,-1),(1,1)), Line((-1,1), (1,-1))) == FiniteSet(Point2D(0,0)). New module sympy.series.fourier for computing fourier sine/cosine series. [PR #9523] Linsolve: General Linear System Solver in sympy.solvers.solveset, use linsolve() for solving all types of linear systems. PR #9438 New assumption system is now able to read the assumptions set over Symbol object. For e.g.: In [7]: x = Symbol('x', positive=True) In [8]: ask(Q.positive(x)) Out[8]: True A new handler system has been added as sympy.assumptions.satask which uses satisfiable to answer queries related to assumptions. In case the legacy ask doesn't know the answer, it falls back on satask. For e.g. Earlier >>> ask(Q.zero(x) | Q.zero(y), Q.zero(x*y)) >>> ask(Implies(Q.zero(x), Q.zero(x*y))) >>> ask(Q.zero(x) | Q.zero(y), Q.nonzero(x*y)) Now >>> ask(Q.zero(x) | Q.zero(y), Q.zero(x*y)) True >>> ask(Implies(Q.zero(x), Q.zero(x*y))) True >>> ask(Q.zero(x) | Q.zero(y), Q.nonzero(x*y)) False New module sympy.series.formal for computing formal power series. [PR #9639] New set class ConditionSet was implemented. [PR #9696] Differential calculus Methods, like is_increasing, is_monotonic, etc were implemented in sympy.calculus.singularities in [PR #9820] New module sympy.series.limitseq for finding limits of terms containing sequences. [PR #9836] New module sympy/polys/subresultants_qq_zz.py :: contains various functions for computing Euclidean, Sturmian and (modified) subresultant polynomial remainder sequences in Q[x] or Z[x]. All methods are based on the recently discovered theorem by Pell and Gordon of 1917 and an extension/generalization of it of 2015. [PR #10374] Minor changes limit(sin(x), x, oo) now returns AccumulationBound object instead of un-evaluated sin(oo). Implemented in [PR #10051]. Point is now an n-dimensional point and subclassed to Point2D and Poin3D where appropriate. Point is also now enumerable and can be indexed (e.g., x=Point(1,2,3); x[0]) roots_cubic will no longer raise an error when the sign of certain expressions is unknown. It will return a generally valid solution instead. Relational.canonical will put a Relational into canonical form which is useful for testing whether two Relationals are trivially the same. Relational.reversed gives the Relational with lhs and rhs reversed and the symbol updated accordingly (e.g. (x < 1).reversed -> 1 > x Simplification of Relationals will, if the threshold for simplification is met, also return the Relational in canonical form. One of the criteria of being in canonical form is that the Number will be on the rhs. This makes writing tests a little easier so S(1) > x can be entered as 1 > x or x < 1 (the former being turned into the latter by Python). boolalg functions And, Or, Implies, Xor, Equivalent are aware of Relational complements and trivial equalities, so, for example, And(x=1) will reduce to False while And(S(1)>x,x<1) reduces to x < 1. This leads to some simplifications in statistical expressions. Polynomials created using ring now accept negative and fractional exponents. For e.g, In [1]: R, x, y = ring('x, y', QQ) In [2]: x**(-2) + y**Rational(2,3) Out[2]: y**(2/3) + x**(-2) The function used to test connectivity in Min and Max has been altered to use the weaker form of a relationship since this applies to arguments like floor(x) and x: though, in generally, we cannot say that floor(x) < x, if x is real we do know that floor(x) <= x. This allows Min(x, floor(x)) -> floor(x) without loss of generality when x is real. Float has changed its default behaviour on string/int/long to use at least 15 digits of precision and to increase the precision automatically. This enables sympify('1.23456789012345678901234567890') to return a high-precision Float. It also means N('1.23456789012345678901234567890', 20) does the right thing (where it previously lost precision because an intermediate calculation had only precision 15). See Issue #8821 The unicode pretty printer now uses a compact single-character square root symbol for simple expressions like sqrt(x) and sqrt(17). You can disable this new behaviour with pprint(sqrt(2), use_unicode_sqrt_char=False). ask(Q.finite(x), Q.infinite(x)) now returns False. You can now read the definition of assumption predicates in the docs. ask(Q.composite(1)) now returns False. exp(expr) won't simplify automatically based on assumptions on expr. Autosimplification works for numbers and Symbol, though. You'll have to call refine on exp for simplification. Idx objects can now be summation variables of Sum and Product. The keyword argument of GramSchmidt was renamed from "orthog" to "orthonormal". This is because GramSchmidt always returns an orthogonal set of vectors but only if that argument is True does it return an orthonormal set of vectors. RootOf now has a new subclass ComplexRootOf (abbreviated CRootOf). All currently defined functionality is in the subclass. There is a new function rootof with the same call interface as that of RootOf. It will create objects of CRootOf. New code should use rootof instead of RootOf which is planned to become an abstract class. The vector module has a new function orthogonalize which applies the Gram Schmidt orthogonalization on a sequence of linearly independent vectors and returns a sequence of orthogonal (or orthonormal) vectors. The projection method has been added to compute the vector (or scalar) projection of one vector on another vector. (See https://github.com/sympy/sympy/pull/10474#) Update by K.I.A.Derouiche in PR pkg/51270
2016-08-16Update py-pandas to 0.18.1maya3-100/+446
Highlights in changelog: v0.18.1: .groupby(...) has been enhanced to provide convenient syntax when working with .rolling(..), .expanding(..) and .resample(..) per group, see here pd.to_datetime() has gained the ability to assemble dates from a DataFrame, see here Method chaining improvements, see here. Custom business hour offset, see here. Many bug fixes in the handling of sparse, see here Expanded the Tutorials section with a feature on modern pandas, courtesy of @TomAugsburger. (GH13045). v0.18.0: Moving and expanding window functions are now methods on Series and DataFrame, similar to .groupby, see here. Adding support for a RangeIndex as a specialized form of the Int64Index for memory savings, see here. API breaking change to the .resample method to make it more .groupby like, see here. Removal of support for positional indexing with floats, which was deprecated since 0.14.0. This will now raise a TypeError, see here. The .to_xarray() function has been added for compatibility with the xarray package, see here. The read_sas function has been enhanced to read sas7bdat files, see here. Addition of the .str.extractall() method, and API changes to the .str.extract() method and .str.cat() method. pd.test() top-level nose test runner is available (GH4327). Update by K.I.A.Derouiche in PR pkg/51272 Slightly modified.
2016-08-16Update py-pytables to 3.2.3maya5-46/+51
Changes from 3.2.2 to 3.2.3 Improvements It is now possible to use HDF5 with the new shared library naming scheme (>= 1.8.10, hdf5.dll instead of hdf5dll.dll) on Windows (gh-540). Thanks to Tadeu Manoel. Now :program: ptdump sorts output by node name and does not print a backtrace if file cannot be opened. Thanks to Zbigniew Jędrzejewski-Szmek. Bugs fixed Only run tables.tests.test_basics.UnicodeFilename if the filesystem encoding is utf-8. Closes gh-485. Add lib64 to posix search path. (closes gh-507) Thanks to Mehdi Sadeghi. Ensure cache entries are removed if fewer than 10 (closes gh-529). Thanks to Graham Jones. Fix segmentation fault in a number of test cases that use index.Index (closes gh-532 and gh-533). Thanks to Diane Trout. Fixed the evaluation of transcendental functions when numexpr is compiled with VML support (closes gh-534, PR #536). Thanks to Tom Kooij. Make sure that index classes use buffersizes that are a multiple of chunkshape[0] (closes gh-538, PR #538). Thanks to Tom Kooij. Ensure benchmark paths exist before benchmarks are executed (PR #544). Thanks to rohitjamuar. Other changes Minimum Cython version is now v0.21 Changes from 3.2.1.1 to 3.2.2 Bug fixed Fix AssertionError in Row.__init_loop. See gh-477. Fix issues with Cython 0.23. See gh-481. Only run tables.tests.test_basics.UnicodeFilename if the filesystem encoding is utf-8. Closes gh-485. Fix missing missing PyErr_Clear. See gh-#486. Fix the C type of some numpy attributes. See gh-494. Cast selection indices to integer. See gh-496. Fix indexesextension._keysort_string. Closes gh-497 and gh-498. Changes from 3.2.1 to 3.2.1.1 Fix permission on distributed source distribution Other changes Minimum Cython version is now v0.21 Changes from 3.2.0 to 3.2.1 Bug fixed Fix indexesextension._keysort. Fixes gh-455. Thanks to Andrew Lin. Changes from 3.1.1 to 3.2.0 Improvements The nrowsinbuf is better computed now for EArray/CArray having a small chunkshape in the main dimension. Fixes #285. PyTables should be installable very friendly via pip, including NumPy being installed automatically in the unlikely case it is not yet installed in the system. Thanks to Andrea Bedini. setup.py has been largely simplified and now it requires setuptools. Although we think this is a good step, please keep us informed this is breaking some installation in a very bad manner. setup.py now is able to used pkg-config, if available, to locate required libraries (hdf5, bzip2, etc.). The use of pkg-config can be controlled via setup.py command line flags or via environment variables. Please refer to the installation guide (in the User Manual) for details. Closes gh-442. It is now possible to create a new node whose parent is a softlink to another group (see gh-422). Thanks to Alistair Muldal. link.SoftLink objects no longer need to be explicitly dereferenced. Methods and attributes of the linked object are now automatically accessed when the user acts on a soft-link (see gh-399). Thanks to Alistair Muldal. Now ptrepack recognizes hardlinks and replicates them in the output (repacked) file. This saves disk space and makes repacked files more conformal to the original one. Closes gh-380. New pttree script for printing HDF5 file contents as a pretty ASCII tree (closes gh-400). Thanks to Alistair Muldal. The internal Blosc library has been downgraded to version 1.4.4. This is in order to still allow using multiple threads inside Blosc, even on multithreaded applications (see gh-411, gh-412, gh-437 and gh-448). The print_versions() function now also reports the version of compression libraries used by Blosc. Now the setup.py tries to use the ‘-march=native’ C flag by default. In falls back on ‘-msse2’ if ‘-march=native’ is not supported by the compiler. Closes gh-379. Fixed a spurious unicode comparison warning (closes gh-372 and gh-373). Improved handling of empty string attributes. In previous versions of PyTables empty string were stored as scalar HDF5 attributes having size 1 and value ‘0’ (an empty null terminated string). Now empty string are stored as HDF5 attributes having zero size Added a new cookbook recipe and a couple of examples for simple threading with PyTables. The redundant utilsextension.get_indices() function has been eliminated (replaced by slice.indices()). Closes gh-195. Allow negative indices in point selection (closes gh-360) Index wasn’t being used if it claimed there were no results. Closes gh-351 (see also gh-353) Atoms and Col types are no longer generated dynamically so now it is easier for IDEs and static analysis tool to handle them (closes gh-345) The keysort functions in idx-opt.c have been cythonised using fused types. The perfomance is mostly unchanged, but the code is much more simpler now. Thanks to Andrea Bedini. Small unit tests re-factoring: print_versions() and tests.common.print_heavy() functions moved to the tests.common module always use print_versions() when test modules are called as scripts use the unittest2 package in Python 2.6.x removed internal machinery used to replicate unittest2 features always use tests.common.PyTablesTestCase as base class for all test cases code of the old tasts.common.cleanup() function has been moved to tests.common.PyTablesTestCase.tearDown() method new implementation of tests.common.PyTablesTestCase.assertWarns() compatible with the one provided by the standard unittest module in Python >= 3.2 use tests.common.PyTablesTestCase.assertWarns() as context manager when appropriate use the unittest.skipIf() decorator when appropriate new :class:tests.comon.TestFileMixin: class Bugs fixed Fixed compatibility problems with numpy 1.9 and 1.10-dev (closes gh-362 and gh-366) Fixed compatibility with Cython >= 0.20 (closes gh-386 and gh-387) Fixed support for unicode node names in LRU cache (only Python 2 was affected). Closes gh-367 and gh-369. Fixed support for unicode node titles (only Python 2 was affected). Closes gh-370 and gh-374. Fixed a bug that caused the silent truncation of unicode attributes containing the ‘0’ character. Closes gh-371. Fixed descr_from_dtype() to work as expected with complex types. Closes gh-381. Fixed the tests.test_basics.ThreadingTestCase test case. Closes gh-359. Fix incomplete results when performing the same query twice and exhausting the second iterator before the first. The first one writes incomplete results to seqcache (gh-353) Fix false results potentially going to seqcache if tableextension.Row.update() is used during iteration (see gh-353) Fix Column.create_csindex() when there’s NaNs Fixed handling of unicode file names on windows (closes gh-389) No longer not modify sys.argv at import time (closes gh-405) Fixed a performance issue on NFS (closes gh-402) Fixed a nasty problem affecting results of indexed queries. Closes gh-319 and probably gh-419 too. Fixed another problem affecting results of indexed queries too. Closes gh-441. Replaced “len(xrange(start, stop, step))” -> “len(xrange(0, stop - start, step))” to fix issues with large row counts with Python 2.x. Fixes #447. Other changes Cython is not a hard dependency anymore (although developers will need it so as to generated the C extension code). The number of threads used by default for numexpr and Blosc operation that was set to the number of available cores have been reduced to 2. This is a much more reasonable setting for not creating too much overhead.
2016-08-15Standardize dependency pattern.wiz1-3/+3
2016-08-15Update Darwin-specifix PLIST with new timezones.jperkin1-1/+6
2016-08-13Add missing "tex-*" packages required to build the documentationtron1-1/+3
2016-08-12Update to 1.11wen3-20/+19
Update DEPENDS Based on PR/51271 from kamelderouiche@yahoo.com Upstream changes: 1.11 API changes [#1930] No longer import nx_agraph and nx_pydot into the top-level namespace. They can be accessed within networkx as e.g. nx.nx_agraph.write_dot or imported as from networkx.drawing.nx_agraph import write_dot. [#1750] Arguments center and scale are now available for all layout functions. The defaul values revert to the v1.9 values (center is the origin for circular layouts and domain is [0, scale) for others. [#1924] Replace pydot with pydotplus for drawing with the pydot interface. [#1888] Replace support for Python3.2 with support for Python 3.5. Miscellaneous changes [#1763] Set up appveyor to automatically test installation on Windows machines. Remove symbolic links in examples to help such istallation. Change many doc_string typos to allow sphinx to build the docs without errors or warnings. Enable the docs to be automatically built on readthedocs.org by changing requirements.txt
2016-08-10Update gnome-calculator to 3.20.2prlw12-8/+7
Overview of changes in gnome-calculator 3.20.2 * lib: prevents segfault when elements of division to zero have null assigned tokens (fixes #769364) (Alberto Ruiz) * Updated Indonesian translation (Andika Triwidada) * Updated Norwegian bokmål translation. (Kjartan Maraas)
2016-08-09Update to 1.24wen2-9/+8
Add LICENSE Upstream changes: 1.24 2015-03-01 CHORNY - Added SEE ALSO section with links to similar modules. - Reformatted this file as per CPAN::Changes::Spec - Improved wording of the abstract
2016-08-09Update to 0.59wen2-7/+7
Upstream changes: 0.59 2016-08-03 [ADDED] - is_prime_power Returns k if n=p^k for p a prime. - logint(n,b) Integer logarithm. Largest e s.t. b^e <= n. - rootint(n,k) Integer k-th root. - ramanujan_sum(k,n) Ramanujan's sum [FUNCTIONALITY AND PERFORMANCE] - Fixes for quadmath: + Fix "infinity" in t/11-primes.t. + Fix native Pi to use quads. + Trim some threading tests. - Fix fromdigits memory error with large string. - Remove 3 threading tests that were causing issues with Perl -DDEBUGGING. - foroddcomposites with some odd start values could index incorrectly. - is_primitive_root(1,0) returns 0 instead of fp exception. - mertens() uses a little less memory. - 2x speedup for znlog with bigint values. - is_pseudoprime() and is_euler_pseudoprime() use Montgomery math so are much faster. They seem to be ~5% faster than Miller-Rabin now. - is_catalan_pseudoprime 1.1x to 1.4x faster. - is_perrin_pseudoprime over 10x faster. Uses Adams/Shanks doubling and Montgomery math. Single core, odd composites: ~8M range/s. - Add restricted Perrin pseudoprimes using an optional argument. - Add bloom filters to reject non-perfect cubes, fifths, and sevenths. is_power about 2-3x faster for native inputs. - forcomposites / foroddcomposites about 1.2x faster past 64-bit. - exp_mangoldt rewritten to use is_prime_power. - Integer root code rewritten and now exported. - We've been hacking around the problem of older Perls autovivifying functions at compile time. This makes functions that don't exist return true when asked if they're defined, which causes us distress. Store the available GMP functions before loading the PP code. XS code knows MPU::GMP version and calls as appropriate. This works around the auto-vivication, and lets us choose to call the GMP function based on version instead of just existence. E.g. GMP's is_power was added in 0.19, but didn't support negative powers until 0.28.
2016-08-09Update to 1.27wen2-8/+9
Upstream changes: 2016-04-25 v1.27 pjacklam * Sync test files with Math-BigInt-1.999719. 2016-04-22 v1.26 pjacklam * Sync test files with Math-BigInt-1.999718. 2016-01-03 v1.25 pjacklam * Sync test files with Math-BigInt-1.999714. 2015-12-31 v1.24 pjacklam * Sync test files with Math-BigInt-1.999713. 2015-11-22 v1.23 pjacklam * Sync test files with Math-BigInt-1.999709. * In v1.22 the required version of Math-BigInt was set to 1.999703, but it should have been 1.999706. The required version is now 1.999709. * Correct error in CHANGES file. 2015-11-09 v1.22 pjacklam * Sync test files with Math-BigInt-1.999709. * Update the README file. * Remove the LICENSE file as this information is already covered in the file README. * Replace 'use vars ...' with 'our ...'. We require a Perl newer than 5.6.0 anyway. * Move 'Test::More' from 'build_requires' to 'test_requires' in Makefile.PL. * Enable 'use warnings'. We require a Perl newer than 5.6.0 anyway. * Add 'assertlib.*\.exe' to MANIFEST.SKIP, since make generates temporary files like 'assertlibzxjE4WfG.exe' on Cygwin. 2015-09-21 v1.21 pjacklam * Sync test files with Math-BigInt-1.999703. * Required version of Math-BigInt is now 1.999703. * Update author information. 2015-09-17 v1.20 pjacklam * Sync test files with Math-BigInt-1.999702. * Required version of Math-BigInt is now 1.999702. 2015-09-11 v1.19 pjacklam bigfltpm.inc * File removed. It was included in the previous release by accident. bigfltpm.t * File removed. It was included in the previous release by accident. bigintpm.inc * File removed. It was included in the previous release by accident. bigintpm.t * File removed. It was included in the previous release by accident. biglog.t * File removed. It was included in the previous release by accident. bigroot.t * File removed. It was included in the previous release by accident. inc/Module/Install.pm * Update bundled Module::Install from v1.08 to v1.16. lib/Math/BigInt/Pari.pm * Updated version number. * Fixed bug in _modpow(). Makefile.PL * Updated required version of Math::BigInt to 1.999701. t/01load.t * Improve formatting of module version information. t/03podcov.t * Slight reformatting and better information message. t/bigfltpm.inc * Sync tests with the Math-BigInt distribution. t/bigfltpm.t * Adjust number of tests. * Sync tests with the Math-BigInt distribution. * Make sure we test Math::BigInt::Pari, not Math::BigInt::Calc. t/bigintpm.inc * Sync tests with the Math-BigInt distribution. t/bigintpm.t * Adjust number of tests. * Make sure we test Math::BigInt::Pari, not Math::BigInt::Calc. t/biglog.t * Adjust number of tests. * Sync tests with the Math-BigInt distribution. * Make sure we test Math::BigInt::Pari, not Math::BigInt::Calc. t/bigroot.t * Adjust number of tests. * Make sure we test Math::BigInt::Pari, not Math::BigInt::Calc. t/*.t * Add "use warnings" to test scripts, since Perl 5.6.2 is required anyway, and "use warnings" was introduced in Perl 5.6.1. * Modified test scripts so the difference between the test files in the Math-BigInt distribution and the backend distributions are as few and as small as possible. This makes for easier release management. 2014-04-03 v1.18 pjacklam * Updated test files from the Math::BigInt distribution (Peter John Acklam). * Updated POD (Peter John Acklam) 2011-09-04 v1.17 pjacklam * Upgrade bundled modules in "inc" to latest version. (Peter John Acklam) * Math::BigInt::GMP now requires Math::BigInt v1.997 (Peter John Acklam). * Include "^MYMETA\.(yml|json)\z" in MANIFEST.SKIP. Whereas META.* are generated by the distribution author at packaging time, MYMETA.* are generated by the end user at configure time after any dynamic dependencies are known. (Peter John Acklam) * Updated common test files from the Math::BigInt distribution. (Peter John Acklam)
2016-08-09Update to 1.51wen3-17/+16
Upstream changes: 2016-04-25 v1.51 pjacklam * Sync test files with Math-BigInt-1.999719. 2016-04-22 v1.50 pjacklam * Sync test files with Math-BigInt-1.999718. 2016-01-03 v1.49 pjacklam * Sync test files with Math-BigInt-1.999714. 2015-12-31 v1.48 pjacklam * Sync test files with Math-BigInt-1.999713. 2015-12-14 v1.47 pjacklam * Add patch from Gregor Herrmann (GREGOA) based on code by Dana Jacobsen (DANAJ) to fix problems with the new() method when Perl is compiled with support for 64-bit integers, but on platforms when the underlying OS is 32-bit (CPAN RT #71548). 2015-12-03 v1.46 pjacklam * Add patch from Dana Jacobsen (DANAJ) and add new test file 't/mbi-from-big-scalar.t' regarding CPAN RT #103517. * Fix spelling in GMP.xs ('modifing' -> 'modifying'). * Whitespace/formatting in t/bigintg.t to make it more readble (for me, at least) and more in accordance with the 'perlstyle' manpage. 2015-11-09 v1.45 pjacklam * Sync test files with Math-BigInt-1.999709. * Required version of Test::More is 0.47. 2015-10-29 v1.44 pjacklam * Sync test files with Math-BigInt-1.999707. * Update the README file. * Remove the files INSTALL and LICENSE as this information is already covered in the file README. * Replace 'use vars ...' with 'our ...'. We require a Perl newer than 5.6.0 anyway. * Required version of Math-BigInt is now 1.999706. * Add 'Test::More' to TEST_REQUIRES in Makefile.PL. * Enable 'use warnings'. We require a Perl newer than 5.6.0 anyway. * Add 'assertlib.*\.exe' to MANIFEST.SKIP, since make generates temporary files like 'assertlibzxjE4WfG.exe' on Cygwin. 2015-09-21 v1.43 pjacklam * Sync test files with Math-BigInt-1.999703. * Required version of Math-BigInt is now 1.999703. * Update author information. 2015-09-17 v1.42 pjacklam * Sync test files with Math-BigInt-1.999702. * Required version of Math-BigInt is now 1.999702. 2015-09-11 v1.41 pjacklam lib/Math/BigInt/GMP.pm * Updated version number. Makefile.PL * Updated required version of Math::BigInt. t/bigfltpm.inc * Synced tests with the Math-BigInt distribution. t/bigfltpm.t * Updated number of tests. t/bigintpm.inc * Synced tests with the Math-BigInt distribution. t/bigintpm.t * Updated number of tests. 2015-08-18 v1.40 pjacklam CHANGES * Add changes for the newest release. * Reorder change entries into descending chronological order. lib/Devel/CheckLib.pm * Update bundled Devel::CheckLib from v1.01 to v1.03. Makefile.PL * Update required version of Math-BigInt to 1.9994. t/01load.t * Improve formatting of module version information. t/bigfltpm.t * Use the correct backend, in this case Math::BigInt::GMP. * Skip test specific for the Math::BigInt::Calc backend. t/bigintpm.inc * Rather than an early exit(), use skip() to skip tests. t/bigintpm.t * Use the correct backend, in this case Math::BigInt::GMP. t/biglog.t * Use the correct backend, in this case Math::BigInt::GMP. This was correct in v1.21, but has been wrong since then. t/bigroot.t * Use the correct backend, in this case Math::BigInt::GMP. This was correct up until v1.32, but has been wrong since then. lib/Math/BigInt/GMP.pm * Increment Math::BigInt::GMP version number to 1.40. 2015-08-17 v1.39 pjacklam * Updated test files with those from Math-BigInt-1.9997. 2014-04-03 v1.38 pjacklam * Updated test files from the Math::BigInt distribution (Peter John Acklam). * Updated POD (Peter John Acklam) * Updated bundled Devel::CheckLib from v0.93 to v1.01 (Peter John Acklam).