pkgsrc-Changes-HG archive

[Date Prev][Date Next][Thread Prev][Thread Next][Date Index][Thread Index][Old Index]

[pkgsrc/trunk]: pkgsrc/math/py-scipy Updated py-scipy to 0.18.0.



details:   https://anonhg.NetBSD.org/pkgsrc/rev/8096ef019e9c
branches:  trunk
changeset: 351342:8096ef019e9c
user:      wiz <wiz%pkgsrc.org@localhost>
date:      Fri Aug 19 10:54:12 2016 +0000

description:
Updated py-scipy to 0.18.0.

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.

diffstat:

 math/py-scipy/Makefile |  20 +++++++++----
 math/py-scipy/PLIST    |  74 +++++++++++++++++++++++++++++++++++++++++--------
 math/py-scipy/distinfo |  10 +++---
 3 files changed, 80 insertions(+), 24 deletions(-)

diffs (272 lines):

diff -r d958093b77f4 -r 8096ef019e9c math/py-scipy/Makefile
--- a/math/py-scipy/Makefile    Fri Aug 19 10:13:50 2016 +0000
+++ b/math/py-scipy/Makefile    Fri Aug 19 10:54:12 2016 +0000
@@ -1,18 +1,15 @@
-# $NetBSD: Makefile,v 1.20 2016/04/23 22:51:57 markd Exp $
+# $NetBSD: Makefile,v 1.21 2016/08/19 10:54:12 wiz Exp $
 
-DISTNAME=      scipy-0.17.0
+DISTNAME=      scipy-0.18.0
 PKGNAME=       ${PYPKGPREFIX}-${DISTNAME}
 CATEGORIES=    math python
-MASTER_SITES=  ${MASTER_SITE_GITHUB:=scipy/}
-GITHUB_PROJECT=        scipy
-GITHUB_TAG=    v${PKGVERSION_NOREV}
+MASTER_SITES=  ${MASTER_SITE_PYPI:=s/scipy/}
 
 MAINTAINER=    markd%NetBSD.org@localhost
 HOMEPAGE=      http://www.scipy.org/
 COMMENT=       Scientific Algorithms Library for Python
 LICENSE=       modified-bsd
 
-PLIST_SUBST+=   PYPKGPREFIX=${PYPKGPREFIX}
 USE_LANGUAGES+=        c c++ fortran
 MAKE_ENV+=     ATLAS=None
 
@@ -103,9 +100,20 @@
        done
 .endif
 
+# TEST_DEPENDS
+BUILD_DEPENDS+=        ${PYPKGPREFIX}-nose-[0-9]*:../../devel/py-nose
+
+# support files for tests missing in 0.18.0 on pypi
+# https://github.com/scipy/scipy/issues/6498
+# self test failures reported at
+# https://github.com/scipy/scipy/issues/6499
+do-test:
+       cd ${WRKSRC} && ${PYTHONBIN} runtests.py -v
+
 .include "../../lang/python/application.mk"
 .include "../../lang/python/distutils.mk"
 .include "../../devel/py-cython/buildlink3.mk"
 .include "../../math/fftw/buildlink3.mk"
+BUILDLINK_API_DEPENDS.py-numpy+=       ${PYPKGPREFIX}-numpy>=1.7.1
 .include "../../math/py-numpy/buildlink3.mk"
 .include "../../mk/bsd.pkg.mk"
diff -r d958093b77f4 -r 8096ef019e9c math/py-scipy/PLIST
--- a/math/py-scipy/PLIST       Fri Aug 19 10:13:50 2016 +0000
+++ b/math/py-scipy/PLIST       Fri Aug 19 10:54:12 2016 +0000
@@ -1,5 +1,8 @@
-@comment $NetBSD: PLIST,v 1.9 2016/04/23 22:51:57 markd Exp $
-${PYSITELIB}/${EGG_FILE}
+@comment $NetBSD: PLIST,v 1.10 2016/08/19 10:54:12 wiz Exp $
+${PYSITELIB}/${EGG_FILE}/PKG-INFO
+${PYSITELIB}/${EGG_FILE}/SOURCES.txt
+${PYSITELIB}/${EGG_FILE}/dependency_links.txt
+${PYSITELIB}/${EGG_FILE}/top_level.txt
 ${PYSITELIB}/scipy/BENTO_BUILD.txt
 ${PYSITELIB}/scipy/HACKING.rst.txt
 ${PYSITELIB}/scipy/INSTALL.rst.txt
@@ -29,6 +32,9 @@
 ${PYSITELIB}/scipy/_lib/_testutils.py
 ${PYSITELIB}/scipy/_lib/_testutils.pyc
 ${PYSITELIB}/scipy/_lib/_testutils.pyo
+${PYSITELIB}/scipy/_lib/_threadsafety.py
+${PYSITELIB}/scipy/_lib/_threadsafety.pyc
+${PYSITELIB}/scipy/_lib/_threadsafety.pyo
 ${PYSITELIB}/scipy/_lib/_tmpdirs.py
 ${PYSITELIB}/scipy/_lib/_tmpdirs.pyc
 ${PYSITELIB}/scipy/_lib/_tmpdirs.pyo
@@ -48,6 +54,7 @@
 ${PYSITELIB}/scipy/_lib/six.pyc
 ${PYSITELIB}/scipy/_lib/six.pyo
 ${PYSITELIB}/scipy/_lib/tests/test__gcutils.py
+${PYSITELIB}/scipy/_lib/tests/test__threadsafety.py
 ${PYSITELIB}/scipy/_lib/tests/test__util.py
 ${PYSITELIB}/scipy/_lib/tests/test__version.py
 ${PYSITELIB}/scipy/_lib/tests/test_tmpdirs.py
@@ -121,6 +128,9 @@
 ${PYSITELIB}/scipy/integrate/__init__.py
 ${PYSITELIB}/scipy/integrate/__init__.pyc
 ${PYSITELIB}/scipy/integrate/__init__.pyo
+${PYSITELIB}/scipy/integrate/_bvp.py
+${PYSITELIB}/scipy/integrate/_bvp.pyc
+${PYSITELIB}/scipy/integrate/_bvp.pyo
 ${PYSITELIB}/scipy/integrate/_dop.so
 ${PYSITELIB}/scipy/integrate/_ode.py
 ${PYSITELIB}/scipy/integrate/_ode.pyc
@@ -145,6 +155,7 @@
 ${PYSITELIB}/scipy/integrate/tests/_test_multivariate.c
 ${PYSITELIB}/scipy/integrate/tests/banded5x5.f
 ${PYSITELIB}/scipy/integrate/tests/test_banded_ode_solvers.py
+${PYSITELIB}/scipy/integrate/tests/test_bvp.py
 ${PYSITELIB}/scipy/integrate/tests/test_integrate.py
 ${PYSITELIB}/scipy/integrate/tests/test_odeint_jac.py
 ${PYSITELIB}/scipy/integrate/tests/test_quadpack.py
@@ -153,11 +164,11 @@
 ${PYSITELIB}/scipy/interpolate/__init__.py
 ${PYSITELIB}/scipy/interpolate/__init__.pyc
 ${PYSITELIB}/scipy/interpolate/__init__.pyo
+${PYSITELIB}/scipy/interpolate/_cubic.py
+${PYSITELIB}/scipy/interpolate/_cubic.pyc
+${PYSITELIB}/scipy/interpolate/_cubic.pyo
 ${PYSITELIB}/scipy/interpolate/_fitpack.so
 ${PYSITELIB}/scipy/interpolate/_interpolate.so
-${PYSITELIB}/scipy/interpolate/_monotone.py
-${PYSITELIB}/scipy/interpolate/_monotone.pyc
-${PYSITELIB}/scipy/interpolate/_monotone.pyo
 ${PYSITELIB}/scipy/interpolate/_ppoly.so
 ${PYSITELIB}/scipy/interpolate/dfitpack.so
 ${PYSITELIB}/scipy/interpolate/fitpack.py
@@ -281,6 +292,7 @@
 ${PYSITELIB}/scipy/io/matlab/tests/data/japanese_utf8.txt
 ${PYSITELIB}/scipy/io/matlab/tests/data/little_endian.mat
 ${PYSITELIB}/scipy/io/matlab/tests/data/logical_sparse.mat
+${PYSITELIB}/scipy/io/matlab/tests/data/malformed1.mat
 ${PYSITELIB}/scipy/io/matlab/tests/data/miuint32_for_miint32.mat
 ${PYSITELIB}/scipy/io/matlab/tests/data/miutf8_array_name.mat
 ${PYSITELIB}/scipy/io/matlab/tests/data/nasty_duplicate_fieldnames.mat
@@ -418,6 +430,7 @@
 ${PYSITELIB}/scipy/io/tests/data/array_float32_pointer_8d.sav
 ${PYSITELIB}/scipy/io/tests/data/example_1.nc
 ${PYSITELIB}/scipy/io/tests/data/example_2.nc
+${PYSITELIB}/scipy/io/tests/data/example_3_maskedvals.nc
 ${PYSITELIB}/scipy/io/tests/data/fortran-mixed.dat
 ${PYSITELIB}/scipy/io/tests/data/fortran-sf8-10x1x11.dat
 ${PYSITELIB}/scipy/io/tests/data/fortran-sf8-1x1x1.dat
@@ -448,6 +461,7 @@
 ${PYSITELIB}/scipy/io/tests/data/scalar_uint32.sav
 ${PYSITELIB}/scipy/io/tests/data/scalar_uint64.sav
 ${PYSITELIB}/scipy/io/tests/data/struct_arrays.sav
+${PYSITELIB}/scipy/io/tests/data/struct_arrays_byte_idl80.sav
 ${PYSITELIB}/scipy/io/tests/data/struct_arrays_replicated.sav
 ${PYSITELIB}/scipy/io/tests/data/struct_arrays_replicated_3d.sav
 ${PYSITELIB}/scipy/io/tests/data/struct_inherit.sav
@@ -843,21 +857,22 @@
 ${PYSITELIB}/scipy/signal/_savitzky_golay.pyc
 ${PYSITELIB}/scipy/signal/_savitzky_golay.pyo
 ${PYSITELIB}/scipy/signal/_spectral.so
+${PYSITELIB}/scipy/signal/_upfirdn.py
+${PYSITELIB}/scipy/signal/_upfirdn.pyc
+${PYSITELIB}/scipy/signal/_upfirdn.pyo
+${PYSITELIB}/scipy/signal/_upfirdn_apply.so
 ${PYSITELIB}/scipy/signal/bsplines.py
 ${PYSITELIB}/scipy/signal/bsplines.pyc
 ${PYSITELIB}/scipy/signal/bsplines.pyo
-${PYSITELIB}/scipy/signal/cont2discrete.py
-${PYSITELIB}/scipy/signal/cont2discrete.pyc
-${PYSITELIB}/scipy/signal/cont2discrete.pyo
-${PYSITELIB}/scipy/signal/dltisys.py
-${PYSITELIB}/scipy/signal/dltisys.pyc
-${PYSITELIB}/scipy/signal/dltisys.pyo
 ${PYSITELIB}/scipy/signal/filter_design.py
 ${PYSITELIB}/scipy/signal/filter_design.pyc
 ${PYSITELIB}/scipy/signal/filter_design.pyo
 ${PYSITELIB}/scipy/signal/fir_filter_design.py
 ${PYSITELIB}/scipy/signal/fir_filter_design.pyc
 ${PYSITELIB}/scipy/signal/fir_filter_design.pyo
+${PYSITELIB}/scipy/signal/lti_conversion.py
+${PYSITELIB}/scipy/signal/lti_conversion.pyc
+${PYSITELIB}/scipy/signal/lti_conversion.pyo
 ${PYSITELIB}/scipy/signal/ltisys.py
 ${PYSITELIB}/scipy/signal/ltisys.pyc
 ${PYSITELIB}/scipy/signal/ltisys.pyo
@@ -883,6 +898,7 @@
 ${PYSITELIB}/scipy/signal/tests/test_savitzky_golay.py
 ${PYSITELIB}/scipy/signal/tests/test_signaltools.py
 ${PYSITELIB}/scipy/signal/tests/test_spectral.py
+${PYSITELIB}/scipy/signal/tests/test_upfirdn.py
 ${PYSITELIB}/scipy/signal/tests/test_waveforms.py
 ${PYSITELIB}/scipy/signal/tests/test_wavelets.py
 ${PYSITELIB}/scipy/signal/tests/test_windows.py
@@ -1095,6 +1111,9 @@
 ${PYSITELIB}/scipy/spatial/_procrustes.py
 ${PYSITELIB}/scipy/spatial/_procrustes.pyc
 ${PYSITELIB}/scipy/spatial/_procrustes.pyo
+${PYSITELIB}/scipy/spatial/_spherical_voronoi.py
+${PYSITELIB}/scipy/spatial/_spherical_voronoi.pyc
+${PYSITELIB}/scipy/spatial/_spherical_voronoi.pyo
 ${PYSITELIB}/scipy/spatial/ckdtree.so
 ${PYSITELIB}/scipy/spatial/distance.py
 ${PYSITELIB}/scipy/spatial/distance.pyc
@@ -1136,13 +1155,36 @@
 ${PYSITELIB}/scipy/spatial/tests/test_distance.py
 ${PYSITELIB}/scipy/spatial/tests/test_kdtree.py
 ${PYSITELIB}/scipy/spatial/tests/test_qhull.py
+${PYSITELIB}/scipy/spatial/tests/test_spherical_voronoi.py
 ${PYSITELIB}/scipy/special/__init__.py
 ${PYSITELIB}/scipy/special/__init__.pyc
 ${PYSITELIB}/scipy/special/__init__.pyo
+${PYSITELIB}/scipy/special/_comb.so
 ${PYSITELIB}/scipy/special/_ellip_harm.py
 ${PYSITELIB}/scipy/special/_ellip_harm.pyc
 ${PYSITELIB}/scipy/special/_ellip_harm.pyo
 ${PYSITELIB}/scipy/special/_ellip_harm_2.so
+${PYSITELIB}/scipy/special/_mptestutils.py
+${PYSITELIB}/scipy/special/_mptestutils.pyc
+${PYSITELIB}/scipy/special/_mptestutils.pyo
+${PYSITELIB}/scipy/special/_precompute/__init__.py
+${PYSITELIB}/scipy/special/_precompute/__init__.pyc
+${PYSITELIB}/scipy/special/_precompute/__init__.pyo
+${PYSITELIB}/scipy/special/_precompute/gammainc_asy.py
+${PYSITELIB}/scipy/special/_precompute/gammainc_asy.pyc
+${PYSITELIB}/scipy/special/_precompute/gammainc_asy.pyo
+${PYSITELIB}/scipy/special/_precompute/gammainc_data.py
+${PYSITELIB}/scipy/special/_precompute/gammainc_data.pyc
+${PYSITELIB}/scipy/special/_precompute/gammainc_data.pyo
+${PYSITELIB}/scipy/special/_precompute/setup.py
+${PYSITELIB}/scipy/special/_precompute/setup.pyc
+${PYSITELIB}/scipy/special/_precompute/setup.pyo
+${PYSITELIB}/scipy/special/_precompute/utils.py
+${PYSITELIB}/scipy/special/_precompute/utils.pyc
+${PYSITELIB}/scipy/special/_precompute/utils.pyo
+${PYSITELIB}/scipy/special/_spherical_bessel.py
+${PYSITELIB}/scipy/special/_spherical_bessel.pyc
+${PYSITELIB}/scipy/special/_spherical_bessel.pyo
 ${PYSITELIB}/scipy/special/_testutils.py
 ${PYSITELIB}/scipy/special/_testutils.pyc
 ${PYSITELIB}/scipy/special/_testutils.pyo
@@ -1177,13 +1219,20 @@
 ${PYSITELIB}/scipy/special/tests/test_basic.py
 ${PYSITELIB}/scipy/special/tests/test_boxcox.py
 ${PYSITELIB}/scipy/special/tests/test_data.py
+${PYSITELIB}/scipy/special/tests/test_digamma.py
 ${PYSITELIB}/scipy/special/tests/test_ellip_harm.py
+${PYSITELIB}/scipy/special/tests/test_gammainc.py
 ${PYSITELIB}/scipy/special/tests/test_lambertw.py
+${PYSITELIB}/scipy/special/tests/test_loggamma.py
 ${PYSITELIB}/scipy/special/tests/test_logit.py
 ${PYSITELIB}/scipy/special/tests/test_mpmath.py
 ${PYSITELIB}/scipy/special/tests/test_orthogonal.py
 ${PYSITELIB}/scipy/special/tests/test_orthogonal_eval.py
+${PYSITELIB}/scipy/special/tests/test_precompute_gammainc.py
+${PYSITELIB}/scipy/special/tests/test_precompute_utils.py
+${PYSITELIB}/scipy/special/tests/test_spence.py
 ${PYSITELIB}/scipy/special/tests/test_spfun_stats.py
+${PYSITELIB}/scipy/special/tests/test_spherical_bessel.py
 ${PYSITELIB}/scipy/stats/__init__.py
 ${PYSITELIB}/scipy/stats/__init__.pyc
 ${PYSITELIB}/scipy/stats/__init__.pyo
@@ -1208,7 +1257,7 @@
 ${PYSITELIB}/scipy/stats/_multivariate.py
 ${PYSITELIB}/scipy/stats/_multivariate.pyc
 ${PYSITELIB}/scipy/stats/_multivariate.pyo
-${PYSITELIB}/scipy/stats/_rank.so
+${PYSITELIB}/scipy/stats/_stats.so
 ${PYSITELIB}/scipy/stats/_stats_mstats_common.py
 ${PYSITELIB}/scipy/stats/_stats_mstats_common.pyc
 ${PYSITELIB}/scipy/stats/_stats_mstats_common.pyo
@@ -1274,7 +1323,6 @@
 ${PYSITELIB}/scipy/stats/vonmises.py
 ${PYSITELIB}/scipy/stats/vonmises.pyc
 ${PYSITELIB}/scipy/stats/vonmises.pyo
-${PYSITELIB}/scipy/stats/vonmises_cython.so
 ${PYSITELIB}/scipy/version.py
 ${PYSITELIB}/scipy/version.pyc
 ${PYSITELIB}/scipy/version.pyo
diff -r d958093b77f4 -r 8096ef019e9c math/py-scipy/distinfo
--- a/math/py-scipy/distinfo    Fri Aug 19 10:13:50 2016 +0000
+++ b/math/py-scipy/distinfo    Fri Aug 19 10:54:12 2016 +0000
@@ -1,6 +1,6 @@
-$NetBSD: distinfo,v 1.8 2016/04/23 22:51:57 markd Exp $
+$NetBSD: distinfo,v 1.9 2016/08/19 10:54:12 wiz Exp $
 
-SHA1 (scipy-0.17.0.tar.gz) = 5f23bd9b1e89a9f8329183cee78e27f80b795c2d
-RMD160 (scipy-0.17.0.tar.gz) = e57f81fe6d4eb6a8262cf186db1163c72fea86d3
-SHA512 (scipy-0.17.0.tar.gz) = c508746edc8a4699fb783849d5db4a43eea4e98e22592c1d05454859437b6eaebadc5980d72dd6b868c8132b94a32e3bdd73286cf994cf2fb1aec6fefdd7dabe
-Size (scipy-0.17.0.tar.gz) = 11474364 bytes
+SHA1 (scipy-0.18.0.tar.gz) = 800c21e3593366c96b2c768c2c2d8b93bd95a7b9
+RMD160 (scipy-0.18.0.tar.gz) = 613f7bccf21386ae3f1d6c8911aa243cbb894354
+SHA512 (scipy-0.18.0.tar.gz) = f73b2cbdce9d6de48af53b65b7e49cbe4513160f1f3b1d6a872a75c071b20e95d28cdbecfd24cb123a39121f0b3f751944666b6e0cb587aada40dac383e8d1e7
+Size (scipy-0.18.0.tar.gz) = 13158573 bytes



Home | Main Index | Thread Index | Old Index