[SciPy-Dev] ANN: SciPy 1.5.0

Evgeni Burovski evgeny.burovskiy at gmail.com
Sun Jun 21 15:27:00 EDT 2020


Thanks for managing it Tyler

вс, 21 июн. 2020 г., 22:21 Tyler Reddy <tyler.je.reddy at gmail.com>:

> Hi all,
>
> On behalf of the SciPy development team I'm pleased to announce
> the release of SciPy 1.5.0.
>
> Sources and binary wheels can be found at:
> https://pypi.org/project/scipy/
> and at:
> https://github.com/scipy/scipy/releases/tag/v1.5.0
>
> One of a few ways to install this release with pip:
>
> pip install scipy==1.5.0
>
> ==========================
> SciPy 1.5.0 Release Notes
> ==========================
>
> SciPy 1.5.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. Before upgrading, we recommend that users check that
> their own code does not use deprecated SciPy functionality (to do so,
> run your code with ``python -Wd`` and check for ``DeprecationWarning`` s).
> Our development attention will now shift to bug-fix releases on the
> 1.5.x branch, and on adding new features on the master branch.
>
> This release requires Python 3.6+ and NumPy 1.14.5 or greater.
>
> For running on PyPy, PyPy3 6.0+ and NumPy 1.15.0 are required.
>
> Highlights of this release
> ----------------------------------
>
> -  wrappers for more than a dozen new ``LAPACK`` routines are now available
>   in `scipy.linalg.lapack`
> -  Improved support for leveraging 64-bit integer size from linear algebra
>   backends
> -  addition of the probability distribution for two-sided one-sample
>   Kolmogorov-Smirnov tests
>
>
> New features
> ============
>
> `scipy.cluster` improvements
> ---------------------------------------
> Initialization of `scipy.cluster.vq.kmeans2` using ``minit="++"`` had a
> quadratic complexity in the number of samples. It has been improved,
> resulting
> in a much faster initialization with quasi-linear complexity.
>
> `scipy.cluster.hierarchy.dendrogram` now respects the ``matplotlib`` color
> palette
>
> `scipy.fft` improvements
> ----------------------------------
> A new keyword-only argument ``plan`` is added to all FFT functions in this
> module. It is reserved for passing in a precomputed plan from libraries
> providing a FFT backend (such as ``PyFFTW`` and ``mkl-fft``), and it is
> currently not used in SciPy.
>
> `scipy.io` improvements
> ---------------------------------
> `scipy.io.wavfile` error messages are more explicit about what's wrong,
> and
> extraneous bytes at the ends of files are ignored instead of raising an
> error
> when the data has successfully been read.
>
> `scipy.io.loadmat` gained a ``simplify_cells`` parameter, which if set to
> ``True`` simplifies the structure of the return value if the ``.mat`` file
> contains cell arrays.
>
> ``pathlib.Path`` objects are now supported in `scipy.io` Matrix Market I/O
> functions
>
> `scipy.linalg` improvements
> --------------------------------------
> `scipy.linalg.eigh` has been improved. Now various ``LAPACK`` drivers can
> be
> selected at will and also subsets of eigenvalues can be requested via
> ``subset_by_value`` keyword. Another keyword ``subset_by_index`` is
> introduced.
> Keywords ``turbo`` and ``eigvals`` are deprecated.
>
> Similarly, standard and generalized Hermitian eigenvalue ``LAPACK``
> routines
> ``?<sy/he>evx`` are added and existing ones now have full ``_lwork``
> counterparts.
>
> Wrappers for the following ``LAPACK`` routines have been added to
> `scipy.linalg.lapack`:
>
> -  ``?getc2``: computes the LU factorization of a general matrix with
> complete
>     pivoting
> -  ``?gesc2``: solves a linear system given an LU factorization from
> ``?getc2``
> -  ``?gejsv``: computes the singular value decomposition of a general
> matrix
>     with higher accuracy calculation of tiny singular values and their
>     corresponding singular vectors
> -  ``?geqrfp``: computes the QR factorization of a general matrix with
>     non-negative elements on the diagonal of R
> -  ``?gtsvx``: solves a linear system with general tridiagonal matrix
> -  ``?gttrf``: computes the LU factorization of a tridiagonal matrix
> -  ``?gttrs``: solves a linear system given an LU factorization from
> ``?gttrf``
> -  ``?ptsvx``: solves a linear system with symmetric positive definite
>     tridiagonal matrix
> -  ``?pttrf``: computes the LU factorization of a symmetric positive
> definite
>     tridiagonal matrix
> -  ``?pttrs``: solves a linear system given an LU factorization from
> ``?pttrf``
> -  ``?pteqr``: computes the eigenvectors and eigenvalues of a positive
> definite
>     tridiagonal matrix
> -  ``?tbtrs``: solves a linear system with a triangular banded matrix
> -  ``?csd``: computes the Cosine Sine decomposition of an
> orthogonal/unitary
>     matrix
>
> Generalized QR factorization routines (``?geqrf``) now have full
> ``_lwork``
> counterparts.
>
> `scipy.linalg.cossin` Cosine Sine decomposition of unitary matrices has
> been
> added.
>
> The function `scipy.linalg.khatri_rao`, which computes the Khatri-Rao
> product,
> was added.
>
> The new function `scipy.linalg.convolution_matrix` constructs the Toeplitz
> matrix representing one-dimensional convolution.
>
> `scipy.optimize` improvements
> -----------------------------------------
> The finite difference numerical differentiation used in various
> ``minimize``
> methods that use gradients has several new features:
>
> -  2-point, 3-point, or complex step finite differences can be used.
> Previously
>   only a 2-step finite difference was available.
> -  There is now the possibility to use a relative step size, previously
> only an
>   absolute step size was available.
> -  If the ``minimize`` method uses bounds the numerical differentiation
> strictly
>   obeys those limits.
> -  The numerical differentiation machinery now makes use of a simple
> cache,
>   which in some cases can reduce the number of function evaluations.
> -  ``minimize``'s ``method= 'powell'`` now supports simple bound
> constraints
>
> There have been several improvements to `scipy.optimize.linprog`:
>
> -  The ``linprog`` benchmark suite has been expanded considerably.
> -  ``linprog``'s dense pivot-based redundancy removal routine and sparse
>   presolve are faster
> -  When ``scikit-sparse`` is available, solving sparse problems with
>   ``method='interior-point'`` is faster
>
> The caching of values when optimizing a function returning both value and
> gradient together has been improved, avoiding repeated function
> evaluations
> when using a ``HessianApproximation`` such as ``BFGS``.
>
> ``differential_evolution`` can now use the modern ``np.random.Generator``
> as
> well as the legacy ``np.random.RandomState`` as a seed.
>
> `scipy.signal` improvements
> --------------------------------------
> A new optional argument ``include_nyquist`` is added to ``freqz``
> functions in
> this module. It is used for including the last frequency (Nyquist
> frequency).
>
> `scipy.signal.find_peaks_cwt` now accepts a ``window_size`` parameter for
> the
> size of the window used to calculate the noise floor.
>
> `scipy.sparse` improvements
> ----------------------------------------
> Outer indexing is now faster when using a 2d column vector to select
> column
> indices.
>
> `scipy.sparse.lil.tocsr` is faster
>
> Fixed/improved comparisons between pydata sparse arrays and sparse matrices
>
> BSR format sparse multiplication performance has been improved.
>
> `scipy.sparse.linalg.LinearOperator` has gained the new ``ndim`` class
> attribute
>
> `scipy.spatial` improvements
> ---------------------------------------
> `scipy.spatial.geometric_slerp` has been added to enable geometric
> spherical linear interpolation on an n-sphere
>
> `scipy.spatial.SphericalVoronoi` now supports calculation of region areas
> in 2D
> and 3D cases
>
> The tree building algorithm used by ``cKDTree`` has improved from quadratic
> worst case time complexity to loglinear. Benchmarks are also now available
> for
> building and querying of balanced/unbalanced kd-trees.
>
> `scipy.special` improvements
> ----------------------------------------
> The following functions now have Cython interfaces in `cython_special`:
>
> -  `scipy.special.erfinv`
> -  `scipy.special.erfcinv`
> -  `scipy.special.spherical_jn`
> -  `scipy.special.spherical_yn`
> -  `scipy.special.spherical_in`
> -  `scipy.special.spherical_kn`
>
> `scipy.special.log_softmax` has been added to calculate the logarithm of
> softmax
> function. It provides better accuracy than
> ``log(scipy.special.softmax(x))`` for
> inputs that make softmax saturate.
>
> `scipy.stats` improvements
> ------------------------------------
> The function for generating random samples in `scipy.stats.dlaplace` has
> been
> improved. The new function is approximately twice as fast with a memory
> footprint reduction between 25 % and 60 % (see gh-11069).
>
> `scipy.stats` functions that accept a seed for reproducible calculations
> using
> random number generation (e.g. random variates from distributions) can now
> use
> the modern ``np.random.Generator`` as well as the legacy
> ``np.random.RandomState`` as a seed.
>
> The ``axis`` parameter was added to `scipy.stats.rankdata`. This allows
> slices
> of an array along the given axis to be ranked independently.
>
> The ``axis`` parameter was added to `scipy.stats.f_oneway`, allowing it to
> compute multiple one-way ANOVA tests for data stored in n-dimensional
> arrays.  The performance of ``f_oneway`` was also improved for some cases.
>
> The PDF and CDF methods for ``stats.geninvgauss`` are now significantly
> faster
> as  the numerical integration to calculate the CDF uses a Cython based
> ``LowLevelCallable``.
>
> Moments of the normal distribution (`scipy.stats.norm`) are now calculated
> using
> analytical formulas instead of numerical integration for greater speed and
> accuracy
>
> Moments and entropy trapezoidal distribution (`scipy.stats.trapz`) are now
> calculated using analytical formulas instead of numerical integration for
> greater speed and accuracy
>
> Methods of the truncated normal distribution (`scipy.stats.truncnorm`),
> especially ``_rvs``, are significantly faster after a complete rewrite.
>
> The `fit` method of the Laplace distribution,  `scipy.stats.laplace`, now
> uses
> the analytical formulas for the maximum likelihood estimates of the
> parameters.
>
> Generation of random variates is now thread safe for all SciPy
> distributions.
> 3rd-party distributions may need to modify the signature of the ``_rvs()``
> method to conform to ``_rvs(self, ..., size=None, random_state=None)``. (A
> one-time VisibleDeprecationWarning is emitted when using non-conformant
> distributions.)
>
> The Kolmogorov-Smirnov two-sided test statistic distribution
> (`scipy.stats.kstwo`) was added. Calculates the distribution of the K-S
> two-sided statistic ``D_n`` for a sample of size n, using a mixture of
> exact
> and asymptotic algorithms.
>
> The new function ``median_abs_deviation`` replaces the deprecated
> ``median_absolute_deviation``.
>
> The ``wilcoxon`` function now computes the p-value for Wilcoxon's signed
> rank
> test using the exact distribution for inputs up to length 25.  The
> function has
> a new ``mode`` parameter to specify how the p-value is to be computed.
> The
> default is ``"auto"``, which uses the exact distribution for inputs up to
> length
> 25 and the normal approximation for larger inputs.
>
> Added a new Cython-based implementation to evaluate guassian kernel
> estimates,
> which should improve the performance of ``gaussian_kde``
>
> The ``winsorize`` function now has a ``nan_policy`` argument for refined
> handling of ``nan`` input values.
>
> The ``binned_statistic_dd`` function with ``statistic="std"`` performance
> was
> improved by ~4x.
>
> ``scipy.stats.kstest(rvs, cdf,...)`` now handles both one-sample and
> two-sample testing. The one-sample variation uses `scipy.stats.ksone`
> (or `scipy.stats.kstwo` with back off to `scipy.stats.kstwobign`) to
> calculate
> the p-value. The two-sample variation, invoked if ``cdf`` is array_like,
> uses
> an algorithm described by Hodges to compute the probability directly, only
> backing off to `scipy.stats.kstwo` in case of overflow. The result in both
> cases is more accurate p-values, especially for two-sample testing with
> smaller (or quite different) sizes.
>
> `scipy.stats.maxwell` performance improvements include a 20 % speed up for
> `fit()`` and 5 % for ``pdf()``
>
> `scipy.stats.shapiro` and `scipy.stats.jarque_bera` now return a named
> tuple
> for greater consistency with other ``stats`` functions
>
> Deprecated features
> ================
>
> `scipy` deprecations
> ----------------------------
>
> `scipy.special` changes
> --------------------------------
> The ``bdtr``, ``bdtrc``, and ``bdtri`` functions are deprecating
> non-negative
> non-integral ``n`` arguments.
>
> `scipy.stats` changes
> -----------------------------
> The function ``median_absolute_deviation`` is deprecated. Use
> ``median_abs_deviation`` instead.
>
> The use of the string ``"raw"`` with the ``scale`` parameter of ``iqr`` is
> deprecated. Use ``scale=1`` instead.
>
> Backwards incompatible changes
> ==========================
>
> `scipy.interpolate` changes
> -------------------------------------
>
> `scipy.linalg` changes
> ------------------------------
> The output signatures of ``?syevr``, ``?heevr`` have been changed from
> ``w, v, info`` to ``w, v, m, isuppz, info``
>
> The order of output arguments ``w``, ``v`` of ``<sy/he>{gv, gvd, gvx}`` is
> swapped.
>
> `scipy.signal` changes
> -------------------------------
> The output length of `scipy.signal.upfirdn` has been corrected, resulting
> outputs may now be shorter for some combinations of up/down ratios and
> input
> signal and filter lengths.
>
> `scipy.signal.resample` now supports a ``domain`` keyword argument for
> specification of time or frequency domain input.
>
> Other changes
> =============
> Improved support for leveraging 64-bit integer size from linear algebra
> backends
> in several parts of the SciPy codebase.
>
> Shims designed to ensure the compatibility of SciPy with Python 2.7 have
> now
> been removed.
>
> Many warnings due to unused imports and unused assignments have been
> addressed.
>
> Many usage examples were added to function docstrings, and many input
> validations and intuitive exception messages have been added throughout the
> codebase.
>
> Early stage adoption of type annotations in a few parts of the codebase
>
>
> Authors
> =======
>
> * @endolith
> * Hameer Abbasi
> * ADmitri +
> * Wesley Alves +
> * Berkay Antmen +
> * Sylwester Arabas +
> * Arne Küderle +
> * Christoph Baumgarten
> * Peter Bell
> * Felix Berkenkamp
> * Jordão Bragantini +
> * Clemens Brunner +
> * Evgeni Burovski
> * Matthias Bussonnier +
> * CJ Carey
> * Derrick Chambers +
> * Leander Claes +
> * Christian Clauss
> * Luigi F. Cruz +
> * dankleeman
> * Andras Deak
> * Milad Sadeghi DM +
> * jeremie du boisberranger +
> * Stefan Endres
> * Malte Esders +
> * Leo Fang +
> * felixhekhorn +
> * Isuru Fernando
> * Andrew Fowlie
> * Lakshay Garg +
> * Gaurav Gijare +
> * Ralf Gommers
> * Emmanuelle Gouillart +
> * Kevin Green +
> * Martin Grignard +
> * Maja Gwozdz
> * Sturla Molden
> * gyu-don +
> * Matt Haberland
> * hakeemo +
> * Charles Harris
> * Alex Henrie
> * Santi Hernandez +
> * William Hickman +
> * Till Hoffmann +
> * Joseph T. Iosue +
> * Anany Shrey Jain
> * Jakob Jakobson
> * Charles Jekel +
> * Julien Jerphanion +
> * Jiacheng-Liu +
> * Christoph Kecht +
> * Paul Kienzle +
> * Reidar Kind +
> * Dmitry E. Kislov +
> * Konrad +
> * Konrad0
> * Takuya KOUMURA +
> * Krzysztof Pióro
> * Peter Mahler Larsen
> * Eric Larson
> * Antony Lee
> * Gregory Lee +
> * Gregory R. Lee
> * Chelsea Liu
> * Cong Ma +
> * Kevin Mader +
> * Maja Gwóźdź +
> * Alex Marvin +
> * Matthias Kümmerer
> * Nikolay Mayorov
> * Mazay0 +
> * G. D. McBain
> * Nicholas McKibben +
> * Sabrina J. Mielke +
> * Sebastian J. Mielke +
> * Miloš Komarčević +
> * Shubham Mishra +
> * Santiago M. Mola +
> * Grzegorz Mrukwa +
> * Peyton Murray
> * Andrew Nelson
> * Nico Schlömer
> * nwjenkins +
> * odidev +
> * Sambit Panda
> * Vikas Pandey +
> * Rick Paris +
> * Harshal Prakash Patankar +
> * Balint Pato +
> * Matti Picus
> * Ilhan Polat
> * poom +
> * Siddhesh Poyarekar
> * Vladyslav Rachek +
> * Bharat Raghunathan
> * Manu Rajput +
> * Tyler Reddy
> * Andrew Reed +
> * Lucas Roberts
> * Ariel Rokem
> * Heshy Roskes
> * Matt Ruffalo
> * Atsushi Sakai +
> * Benjamin Santos +
> * Christoph Schock +
> * Lisa Schwetlick +
> * Chris Simpson +
> * Leo Singer
> * Kai Striega
> * Søren Fuglede Jørgensen
> * Kale-ab Tessera +
> * Seth Troisi +
> * Robert Uhl +
> * Paul van Mulbregt
> * Vasiliy +
> * Isaac Virshup +
> * Pauli Virtanen
> * Shakthi Visagan +
> * Jan Vleeshouwers +
> * Sam Wallan +
> * Lijun Wang +
> * Warren Weckesser
> * Richard Weiss +
> * wenhui-prudencemed +
> * Eric Wieser
> * Josh Wilson
> * James Wright +
> * Ruslan Yevdokymov +
> * Ziyao Zhang +
>
> A total of 129 people contributed to this release.
> People with a "+" by their names contributed a patch for the first time.
> This list of names is automatically generated, and may not be fully
> complete.
>
> Issues closed for 1.5.0
> -------------------------------
>
> * `#1455 <https://github.com/scipy/scipy/issues/1455>`__: ellipord does
> returns bogus values if gstop or gpass are negative...
> * `#1968 <https://github.com/scipy/scipy/issues/1968>`__: correlate2d's
> output does not agree with correlate's output in...
> * `#2744 <https://github.com/scipy/scipy/issues/2744>`__: BUG: optimize:
> '\*\*kw' argument of 'newton_krylov' is not documented
> * `#4755 <https://github.com/scipy/scipy/issues/4755>`__: TypeError: data
> type "<i0" not understood
> * `#4921 <https://github.com/scipy/scipy/issues/4921>`__: scipy.optimize
> maxiter option not working as expected
> * `#5144 <https://github.com/scipy/scipy/issues/5144>`__: RuntimeWarning
> on csgraph.shortest_path when edge lengths are...
> * `#5309 <https://github.com/scipy/scipy/issues/5309>`__: Documentation
> of 'hybr' and 'lm' inconsistent in optimize.root
> * `#6026 <https://github.com/scipy/scipy/issues/6026>`__: Replace
> approx_grad with _numdiff.approx_derivative in scipy.optimize
> * `#6502 <https://github.com/scipy/scipy/issues/6502>`__: Computing
> Eigenvalues in an Interval with LAPACK
> * `#7058 <https://github.com/scipy/scipy/issues/7058>`__: Errors in
> special.bdtri and special.bdtr for non-integer k values
> * `#7700 <https://github.com/scipy/scipy/issues/7700>`__: SuperLU does
> not respect perm_c="NATURAL"
> * `#7895 <https://github.com/scipy/scipy/issues/7895>`__: Improvements to
> io.loadmat
> * `#8205 <https://github.com/scipy/scipy/issues/8205>`__: ValueError in
> scipy.linalg.eigvalsh for large matrix
> * `#8278 <https://github.com/scipy/scipy/issues/8278>`__: Memory limit
> for scipy.sparse.linalg.spsolve with scikit-umfpack
> * `#8327 <https://github.com/scipy/scipy/issues/8327>`__:
> scipy.stats.mstats.winsorize NaN handling
> * `#8341 <https://github.com/scipy/scipy/issues/8341>`__:
> scipy.stats.ks_2samp for masked and unmasked data give different...
> * `#8748 <https://github.com/scipy/scipy/issues/8748>`__:
> scipy.stats.kstest for same distribution: p-values nonuniform
> * `#9042 <https://github.com/scipy/scipy/issues/9042>`__: optimize:
> Incorrect statement about \`jac\` in the \`minimize\`...
> * `#9197 <https://github.com/scipy/scipy/issues/9197>`__: problem with
> scipy.signal.butter with 1000+ points array
> * `#9212 <https://github.com/scipy/scipy/issues/9212>`__: EIGH very very
> slow --> suggesting an easy fix
> * `#9553 <https://github.com/scipy/scipy/issues/9553>`__: ndimage
> routines behave badly when output has memory overlap...
> * `#9632 <https://github.com/scipy/scipy/issues/9632>`__:
> ndimage.maximum_filter undocumented behaviour using footprint...
> * `#9658 <https://github.com/scipy/scipy/issues/9658>`__:
> `scipy.optimize.minimize(method='COBYLA')` not threadsafe
> * `#9710 <https://github.com/scipy/scipy/issues/9710>`__:
> stats.weightedtau([1], [1.0]) SEGFAULTs
> * `#9797 <https://github.com/scipy/scipy/issues/9797>`__: Master Tracker
> for some Kolmogorov-Smirnov test Issues
> * `#9844 <https://github.com/scipy/scipy/issues/9844>`__:
> scipy.signal.upfirdn gives different length matrix versus MATLAB...
> * `#9872 <https://github.com/scipy/scipy/issues/9872>`__:
> scipy.signal.convolve is slower when vectorized
> * `#9913 <https://github.com/scipy/scipy/issues/9913>`__: BUG: No dt in
> StateSpace operations
> * `#10014 <https://github.com/scipy/scipy/issues/10014>`__: Distribution
> names \`weibull_min\`and \`weibull_max\` should...
> * `#10159 <https://github.com/scipy/scipy/issues/10159>`__: BUG: stats:
> chisquare returns incorrect results for arrays of...
> * `#10302 <https://github.com/scipy/scipy/issues/10302>`__: scipy.fft:
> Add a \`plan\` argument
> * `#10332 <https://github.com/scipy/scipy/issues/10332>`__: 'Incomplete
> wav chunk' inconsistent/reason unknown
> * `#10441 <https://github.com/scipy/scipy/issues/10441>`__: Remove uses
> of \`numpy.dual\`?
> * `#10558 <https://github.com/scipy/scipy/issues/10558>`__: Document
> implicit sum in csr_matrix() constructor
> * `#10788 <https://github.com/scipy/scipy/issues/10788>`__: LU with full
> pivoting
> * `#10841 <https://github.com/scipy/scipy/issues/10841>`__: Unexpected
> behavior in linalg.blas.dtrmm wrapper
> * `#10919 <https://github.com/scipy/scipy/issues/10919>`__:
> optimize._lbfgsb setulb() function violates parameter bounds
> * `#10963 <https://github.com/scipy/scipy/issues/10963>`__: kstest,
> ks_2samp: confusing \`mode\` argument descriptions
> * `#11022 <https://github.com/scipy/scipy/issues/11022>`__: Unexpected
> Result in factorial function with NaN input
> * `#11028 <https://github.com/scipy/scipy/issues/11028>`__: Documentation
> error in optimize.minimize
> * `#11058 <https://github.com/scipy/scipy/issues/11058>`__: Adding
> logsoftmax function
> * `#11076 <https://github.com/scipy/scipy/issues/11076>`__: ValueError:
> Unknown wave file format
> * `#11090 <https://github.com/scipy/scipy/issues/11090>`__: Misconception
> of the median absolute deviation in stats?
> * `#11095 <https://github.com/scipy/scipy/issues/11095>`__: BUG:
> find_peaks_cwt test failures in 32-bit Linux wheels
> * `#11107 <https://github.com/scipy/scipy/issues/11107>`__:
> scipy.io.mmread generated an error "TypeError: startswith first...
> * `#11123 <https://github.com/scipy/scipy/issues/11123>`__: Add wrapper
> for ?gttrf/?gttrs
> * `#11128 <https://github.com/scipy/scipy/issues/11128>`__: OverflowError
> in resample_poly (upfirdn)
> * `#11132 <https://github.com/scipy/scipy/issues/11132>`__: Possible bug:
> rv_discret.ppf for percentiles 0 and 100 and loc...
> * `#11163 <https://github.com/scipy/scipy/issues/11163>`__: Comparisons
> between scipy spmatrix and can sparse.SparseArray...
> * `#11168 <https://github.com/scipy/scipy/issues/11168>`__: Generalized
> Pareto variance inaccurate for concentrations near...
> * `#11169 <https://github.com/scipy/scipy/issues/11169>`__: Add wrapper
> for ?geqrfp
> * `#11184 <https://github.com/scipy/scipy/issues/11184>`__: 2-sided
> Kolmogorov Smirnov returns p-value of 1
> * `#11185 <https://github.com/scipy/scipy/issues/11185>`__: The .roots()
> or solve() function of scipy.interpolate.CubicHermiteSpline...
> * `#11190 <https://github.com/scipy/scipy/issues/11190>`__: Add wrapper
> for ?tbtrs
> * `#11200 <https://github.com/scipy/scipy/issues/11200>`__: Can no longer
> slice csr_matrix in 1.3.0
> * `#11207 <https://github.com/scipy/scipy/issues/11207>`__:
> _minimize_scalar_bounded: reference before assignment
> * `#11216 <https://github.com/scipy/scipy/issues/11216>`__: linprog:
> interior-point: Cholmod reordering can be reused
> * `#11223 <https://github.com/scipy/scipy/issues/11223>`__: Add wrappers
> for ?pttrf, ?pttrs
> * `#11224 <https://github.com/scipy/scipy/issues/11224>`__: Add
> wrapperfor ?pteqr
> * `#11235 <https://github.com/scipy/scipy/issues/11235>`__: MAINT:
> Missleading Error Message for IIR Filter
> * `#11244 <https://github.com/scipy/scipy/issues/11244>`__: Missing
> reference in \`scipy.optimize.line_search\`
> * `#11262 <https://github.com/scipy/scipy/issues/11262>`__: Hermitian
> Eigenvalue Problem eigh() API and wrapper change proposal
> * `#11266 <https://github.com/scipy/scipy/issues/11266>`__: Sparse matrix
> constructor data type detection changes on Numpy...
> * `#11270 <https://github.com/scipy/scipy/issues/11270>`__: CI failing:
> Travis CI Py36 refguide and Linux_Python_36_32bit_full...
> * `#11279 <https://github.com/scipy/scipy/issues/11279>`__: linalg.eigh
> checks whole array for finite values
> * `#11295 <https://github.com/scipy/scipy/issues/11295>`__: CI: azure
> does not auto-cancel old jobs on pushes
> * `#11299 <https://github.com/scipy/scipy/issues/11299>`__:
> stats.truncnorm.rvs 100x slower in v1.4.x than v1.3.3
> * `#11315 <https://github.com/scipy/scipy/issues/11315>`__: BUG: special:
> rgamma on negative integers smaller -34
> * `#11319 <https://github.com/scipy/scipy/issues/11319>`__: Missing
> \`int64_t\` declaration in rectangular_lsap.cpp
> * `#11323 <https://github.com/scipy/scipy/issues/11323>`__: Compilation
> failure due to missing symbol pthread_atfork
> * `#11332 <https://github.com/scipy/scipy/issues/11332>`__: BUG:
> directed_hausdorff distance on sets u and v when u is a...
> * `#11350 <https://github.com/scipy/scipy/issues/11350>`__: Khatri-Rao
> product
> * `#11354 <https://github.com/scipy/scipy/issues/11354>`__: ENH: Add
> wrapper for ?gejsv
> * `#11361 <https://github.com/scipy/scipy/issues/11361>`__: Dropped NaN
> in eval_genlaguerre function
> * `#11363 <https://github.com/scipy/scipy/issues/11363>`__: Dropped NaN
> in hyperu function
> * `#11365 <https://github.com/scipy/scipy/issues/11365>`__:
> scipy.stats.binned_statistic regressed in v1.4.0
> * `#11369 <https://github.com/scipy/scipy/issues/11369>`__: Dropped NaN
> in eval_hermite
> * `#11370 <https://github.com/scipy/scipy/issues/11370>`__: Dropped NaN
> in eval_gegenbauer
> * `#11373 <https://github.com/scipy/scipy/issues/11373>`__: Add wrapper
> for ?gtsvx
> * `#11374 <https://github.com/scipy/scipy/issues/11374>`__: Add wrapper
> for ?ptsvx
> * `#11391 <https://github.com/scipy/scipy/issues/11391>`__:
> csgraph.minimum_spanning_tree loses precision
> * `#11398 <https://github.com/scipy/scipy/issues/11398>`__: Update stats
> to cope with \`np.random.Generator\` machinery
> * `#11412 <https://github.com/scipy/scipy/issues/11412>`__: Array copying
> causes unwanted type casting from complex to float...
> * `#11415 <https://github.com/scipy/scipy/issues/11415>`__: Where is the
> Wiener Filter derived from?
> * `#11416 <https://github.com/scipy/scipy/issues/11416>`__:
> _lib._util.getargspec_no_self is missing KEYWORD_ONLY support
> * `#11428 <https://github.com/scipy/scipy/issues/11428>`__: Documentation
> on SHGO inequality constraints appears contradictory
> * `#11429 <https://github.com/scipy/scipy/issues/11429>`__: Add LAPACK's
> ZUNCSD cosine sine decomposition
> * `#11438 <https://github.com/scipy/scipy/issues/11438>`__:
> run_dualannealing passes bounds incorrectly in benchmarks/optimize.py
> * `#11441 <https://github.com/scipy/scipy/issues/11441>`__: Can't run
> optimize benchmarks
> * `#11442 <https://github.com/scipy/scipy/issues/11442>`__: Chebyshev
> weights
> * `#11448 <https://github.com/scipy/scipy/issues/11448>`__: Wrongly typed
> comparison in integrate.quad
> * `#11458 <https://github.com/scipy/scipy/issues/11458>`__: BUG:
> maximum_bipartite_matching produces infeasible solution
> * `#11460 <https://github.com/scipy/scipy/issues/11460>`__: CI failing: 2
> Travis CI tests fail with numpy build or version...
> * `#11462 <https://github.com/scipy/scipy/issues/11462>`__: Bug on "++"
> initialization on "kmeans2"
> * `#11464 <https://github.com/scipy/scipy/issues/11464>`__: Shouldn't
> data type of KDE evaluation should be like in the input...
> * `#11468 <https://github.com/scipy/scipy/issues/11468>`__: performance
> of binned_statistics_2d 100x slowdown from 1.3.2...
> * `#11484 <https://github.com/scipy/scipy/issues/11484>`__: Callback
> function doesn't give the same value as the one being...
> * `#11492 <https://github.com/scipy/scipy/issues/11492>`__: Confusing
> dendrogram labelling
> * `#11493 <https://github.com/scipy/scipy/issues/11493>`__:
> scipy.optimize.least_squares fails if the return array of the...
> * `#11494 <https://github.com/scipy/scipy/issues/11494>`__: Error
> performing kronecker product between large sparse vectors
> * `#11503 <https://github.com/scipy/scipy/issues/11503>`__: medfilt
> produces 0 on input of length 1
> * `#11529 <https://github.com/scipy/scipy/issues/11529>`__: Pyflakes
> generates almost 700 warnings.
> * `#11566 <https://github.com/scipy/scipy/issues/11566>`__:
> irfft/irfft2/irfftn docs are slightly confusing re: input type.
> * `#11572 <https://github.com/scipy/scipy/issues/11572>`__:
> least_squares: too small tolerances not catched with method='lm'
> * `#11581 <https://github.com/scipy/scipy/issues/11581>`__: DOC:
> scipy.interpolate.RectSphereBivariateSpline
> * `#11586 <https://github.com/scipy/scipy/issues/11586>`__: Differential
> evolution breaks with LinearConstraints with sparse...
> * `#11595 <https://github.com/scipy/scipy/issues/11595>`__:
> scipy.spatial.cKDTree construction slow for some datasets
> * `#11598 <https://github.com/scipy/scipy/issues/11598>`__: output of
> special.voigt_profile when sigma=0
> * `#11601 <https://github.com/scipy/scipy/issues/11601>`__: linalg tests
> failing in runtests.py
> * `#11602 <https://github.com/scipy/scipy/issues/11602>`__:
> scipy.optimize.linear_sum_assignment returns reverse diagonal...
> * `#11610 <https://github.com/scipy/scipy/issues/11610>`__: Analytic
> formula for normal moments
> * `#11611 <https://github.com/scipy/scipy/issues/11611>`__: Build failure
> with gfortran 10
> * `#11613 <https://github.com/scipy/scipy/issues/11613>`__: TST, MAINT:
> test_quadpack TestCtypesQuad wasn't fully migrated...
> * `#11630 <https://github.com/scipy/scipy/issues/11630>`__:
> SmoothBivariateSpline bbox parameter
> * `#11635 <https://github.com/scipy/scipy/issues/11635>`__: typo in
> docstring of scipy.stats.norminvgauss
> * `#11637 <https://github.com/scipy/scipy/issues/11637>`__: BUG: core
> dumps when calling scipy.interpolate.interp1d with...
> * `#11638 <https://github.com/scipy/scipy/issues/11638>`__: better
> documentation for 'return_all' option in minimize(Nelder...
> * `#11652 <https://github.com/scipy/scipy/issues/11652>`__: TST, MAINT:
> CI failures for pre-release NumPy wheels
> * `#11659 <https://github.com/scipy/scipy/issues/11659>`__:
> optimize.fmin_l_bfgs_b needs bound check and appropiate error...
> * `#11660 <https://github.com/scipy/scipy/issues/11660>`__: BUG/ENH:
> distribution.ncf with nc=0 returns nan
> * `#11661 <https://github.com/scipy/scipy/issues/11661>`__:
> scipy.ndimage.convolve1d and correlate1d don't behave properly...
> * `#11669 <https://github.com/scipy/scipy/issues/11669>`__: p-value
> varies with the order of the data
> * `#11676 <https://github.com/scipy/scipy/issues/11676>`__: documentation
> of scipy.spatial.HalfspaceIntersection: wrong method...
> * `#11685 <https://github.com/scipy/scipy/issues/11685>`__: Rotation
> cannot be expressed as matrix
> * `#11686 <https://github.com/scipy/scipy/issues/11686>`__: MAINT: mypy
> imports of Cython "modules"
> * `#11693 <https://github.com/scipy/scipy/issues/11693>`__:
> TestDifferentialEvolutionSolver::test_L4 failing in CI
> * `#11696 <https://github.com/scipy/scipy/issues/11696>`__: DOC:
> incorrect compiler information for macOS in docs
> * `#11709 <https://github.com/scipy/scipy/issues/11709>`__: eigh() tests
> fail to pass, crash Python with seemingly ramdom...
> * `#11763 <https://github.com/scipy/scipy/issues/11763>`__: Small error
> in gamma continuous rv fit comments
> * `#11769 <https://github.com/scipy/scipy/issues/11769>`__: truncnorm.rvs
> Weird Behaviors
> * `#11770 <https://github.com/scipy/scipy/issues/11770>`__: crash in
> TestEigh::test_value_subsets
> * `#11795 <https://github.com/scipy/scipy/issues/11795>`__: trapz
> distribution mean computed using single precision
> * `#11800 <https://github.com/scipy/scipy/issues/11800>`__: Segmentation
> fault in scipy.odr for multidimensional independent...
> * `#11811 <https://github.com/scipy/scipy/issues/11811>`__: pyflakes
> silently failing on travis-ci
> * `#11826 <https://github.com/scipy/scipy/issues/11826>`__: Error with
> _fblas
> * `#11827 <https://github.com/scipy/scipy/issues/11827>`__:
> \`fft.tests.test_numpy.test_multiprocess\` hangs on Python3.8...
> * `#11835 <https://github.com/scipy/scipy/issues/11835>`__: tests with
> \`multiprocessing\` hang on Python 3.8 on macOS
> * `#11839 <https://github.com/scipy/scipy/issues/11839>`__: linalg.expm
> returns nans with RuntimeWarning: overflow encountered...
> * `#11856 <https://github.com/scipy/scipy/issues/11856>`__: Documentation
> of fit methods for \`weibull_min\` and \`exponweib\`...
> * `#11868 <https://github.com/scipy/scipy/issues/11868>`__: Function
> always evaluated twice when using HessianUpdateStrategy...
> * `#11875 <https://github.com/scipy/scipy/issues/11875>`__: Typo in the
> docstring of simps()
> * `#11877 <https://github.com/scipy/scipy/issues/11877>`__: kmeans2 '++'
> method is orders of magnitude slower than sklearn.cluster.KMeans()
> * `#11884 <https://github.com/scipy/scipy/issues/11884>`__: The upper
> code lines are dead code
> * `#11886 <https://github.com/scipy/scipy/issues/11886>`__: Array shape
> mismatch in scipy.optimize
> * `#11892 <https://github.com/scipy/scipy/issues/11892>`__: BUG: stats:
> Incorrect handling of edges cases by ttest_rel and...
> * `#11908 <https://github.com/scipy/scipy/issues/11908>`__:
> LinearOperator should have ndim attribute
> * `#11910 <https://github.com/scipy/scipy/issues/11910>`__: Documentation
> missing for what M is in init argument
> * `#11922 <https://github.com/scipy/scipy/issues/11922>`__: macOS actions
> CI has started failing in last couple of days.
> * `#11928 <https://github.com/scipy/scipy/issues/11928>`__: DOC: signal:
> Wrong description for sepfir2d, cspline2d, qspline2d
> * `#11944 <https://github.com/scipy/scipy/issues/11944>`__: curve_fit
> documentation unclear on default value of absolute_sigma
> * `#11945 <https://github.com/scipy/scipy/issues/11945>`__: Add a
> (potentially temporary) py.typed file?
> * `#11949 <https://github.com/scipy/scipy/issues/11949>`__: ValueError 'k
> exceeds matrix dimensions' for sparse.diagonal()...
> * `#11951 <https://github.com/scipy/scipy/issues/11951>`__: BUG: asv
> benchmark failed because of cython version
> * `#11967 <https://github.com/scipy/scipy/issues/11967>`__: BLD: Azure
> windows runs complain about drives
> * `#11973 <https://github.com/scipy/scipy/issues/11973>`__:
> oaconvolve(a,b,'same') differs in shape from convolve(a,b,'same')...
> * `#12002 <https://github.com/scipy/scipy/issues/12002>`__: pybind11
> license
> * `#12003 <https://github.com/scipy/scipy/issues/12003>`__: MAINT:
> circular SphericalVoronoi input
> * `#12015 <https://github.com/scipy/scipy/issues/12015>`__: Reordering of
> CSC matrix breaks when you go above int32 limits
> * `#12031 <https://github.com/scipy/scipy/issues/12031>`__: Documentation
> Rendering Issues Visible in CircleCI Artifacts
> * `#12037 <https://github.com/scipy/scipy/issues/12037>`__: MAINT, CI:
> new Cython 3.0a4 issue
> * `#12087 <https://github.com/scipy/scipy/issues/12087>`__: DOC: some odr
> models are missing docs
> * `#12119 <https://github.com/scipy/scipy/issues/12119>`__:
> signal.fftconvolve no longer convolves types f8 and numpy.float64
> * `#12149 <https://github.com/scipy/scipy/issues/12149>`__: Documentation
> of Rosenbrock function
> * `#12173 <https://github.com/scipy/scipy/issues/12173>`__: Large memory
> usage when indexing sparse matrices with \`np.ix_\`
> * `#12178 <https://github.com/scipy/scipy/issues/12178>`__: BUG: stats:
> Some discrete distributions don't accept lists of...
> * `#12220 <https://github.com/scipy/scipy/issues/12220>`__: BUG, REL:
> gh_lists.py compromised scraping
> * `#12239 <https://github.com/scipy/scipy/issues/12239>`__: BUG: median
> absolute deviation handling of nan
> * `#12301 <https://github.com/scipy/scipy/issues/12301>`__: integer
> overflow in scipy.sparse.sputils.check_shape when matrix size > 2^32
> * `#12314 <https://github.com/scipy/scipy/issues/12314>`__:
> scipy.spatial.transform.Rotation multiplication does not normalize
> quaternion
>
> Pull requests for 1.5.0
> ------------------------------
>
> * `#6510 <https://github.com/scipy/scipy/pull/6510>`__: Add Eigenvalue
> Range Functionality for Symmetric Eigenvalue Problems
> * `#9525 <https://github.com/scipy/scipy/pull/9525>`__: BUG: SuperLU
> 'NATURAL' order applies a column permutation
> * `#9634 <https://github.com/scipy/scipy/pull/9634>`__: Add the number of
> Jacobian evaluations to the output of L-BFGS-B.
> * `#9719 <https://github.com/scipy/scipy/pull/9719>`__: ENH: Added kstwo
> probability distribution for two-sided one-sample...
> * `#9783 <https://github.com/scipy/scipy/pull/9783>`__: WIP: optimize:
> added (dense) interpolative decomposition redundancy...
> * `#10053 <https://github.com/scipy/scipy/pull/10053>`__: Adding
> docstring to weibull_min and weibull_max based on issue...
> * `#10136 <https://github.com/scipy/scipy/pull/10136>`__: DEP: Add
> warning to linprog_verbose_callback
> * `#10380 <https://github.com/scipy/scipy/pull/10380>`__: ENH: add
> geometric_slerp
> * `#10602 <https://github.com/scipy/scipy/pull/10602>`__: MAINT:
> optimize: refactor common linprog arguments into namedtuple
> * `#10648 <https://github.com/scipy/scipy/pull/10648>`__: Bounds for the
> Powell minimization method
> * `#10673 <https://github.com/scipy/scipy/pull/10673>`__: ENH:
> approx_fprime --> approx_derivative
> * `#10759 <https://github.com/scipy/scipy/pull/10759>`__: ENH:
> calculation of region areas in spatial.SphericalVoronoi
> * `#10762 <https://github.com/scipy/scipy/pull/10762>`__: BENCH:
> optimize: more comprehensive linprog benchmarking
> * `#10796 <https://github.com/scipy/scipy/pull/10796>`__: ENH exact
> p-values of wilcoxon test in scipy.stats
> * `#10797 <https://github.com/scipy/scipy/pull/10797>`__: ENH: linalg: LU
> with full pivoting (wrappers for ?getc2/?gesc2)
> * `#10824 <https://github.com/scipy/scipy/pull/10824>`__: ENH: Fast
> gaussian kernel estimator
> * `#10942 <https://github.com/scipy/scipy/pull/10942>`__: BUG: prevent
> bound violation in L-BFGS-B optimize method
> * `#11003 <https://github.com/scipy/scipy/pull/11003>`__: ENH: add
> scipy.linalg.convolution_matrix
> * `#11023 <https://github.com/scipy/scipy/pull/11023>`__: improving error
> message for cubic-interpolate with duplicates
> * `#11045 <https://github.com/scipy/scipy/pull/11045>`__: MAINT: make
> bdt{r,rc,ri}() functions accept double n,k args +...
> * `#11063 <https://github.com/scipy/scipy/pull/11063>`__: Fix
> documentation error in optimize.minimize
> * `#11069 <https://github.com/scipy/scipy/pull/11069>`__: ENH:
> stats.dlaplace.rvs improvements
> * `#11071 <https://github.com/scipy/scipy/pull/11071>`__: DOC: Added
> examples to maximum_position in ndimage
> * `#11075 <https://github.com/scipy/scipy/pull/11075>`__: DOC: Update
> stylistic consistency in multiple files
> * `#11097 <https://github.com/scipy/scipy/pull/11097>`__: BUG: stats:
> fixing chisquare to return correct results for arrays...
> * `#11110 <https://github.com/scipy/scipy/pull/11110>`__: ENH: special:
> Cythonise erfinv, erfcinv
> * `#11112 <https://github.com/scipy/scipy/pull/11112>`__: BUG: special:
> Return NaN outside the domain of \`eval_hermite\`
> * `#11114 <https://github.com/scipy/scipy/pull/11114>`__: BUG: special:
> fix \`hyp1f1\` for nonnegative integral \`a\` and...
> * `#11115 <https://github.com/scipy/scipy/pull/11115>`__: DOC: special:
> add docstrings for \`kei\`, \`ker\`, \`keip\`,...
> * `#11130 <https://github.com/scipy/scipy/pull/11130>`__: ENH: support
> for circular input
> * `#11136 <https://github.com/scipy/scipy/pull/11136>`__: BUG: expm
> handling of empty input
> * `#11138 <https://github.com/scipy/scipy/pull/11138>`__: DOC: stylistic
> consistency, punctuation, etc.
> * `#11139 <https://github.com/scipy/scipy/pull/11139>`__: MAINT: cluster:
> use cython_blas, remove handwritten BLAS wrappers
> * `#11146 <https://github.com/scipy/scipy/pull/11146>`__: DOC: update
> docs on bp parameter for detrend
> * `#11151 <https://github.com/scipy/scipy/pull/11151>`__: DOC: special:
> add docstrings for \`bei\`, \`ber\`, \`beip\`,...
> * `#11156 <https://github.com/scipy/scipy/pull/11156>`__: ENH: add input
> validation for ellipord.
> * `#11157 <https://github.com/scipy/scipy/pull/11157>`__: DOC: stylistic
> revision, punctuation, consistency
> * `#11160 <https://github.com/scipy/scipy/pull/11160>`__: ignore warning
> on 0 \* inf in basin hopping
> * `#11162 <https://github.com/scipy/scipy/pull/11162>`__: DOC: minor
> stylistic revision, undo changes
> * `#11164 <https://github.com/scipy/scipy/pull/11164
>
-------------- next part --------------
An HTML attachment was scrubbed...
URL: <http://mail.python.org/pipermail/scipy-dev/attachments/20200621/039b9484/attachment-0001.html>


More information about the SciPy-Dev mailing list