<div dir="ltr">-----BEGIN PGP SIGNED MESSAGE-----<br>Hash: SHA256<br><br>Hi all,<br><br>On behalf of the SciPy development team I'm pleased to announce<br>the release candidate SciPy 1.4.0rc2. Please help us test this pre-release.<br><br>Sources and binary wheels can be found at:<br><a href="https://pypi.org/project/scipy/">https://pypi.org/project/scipy/</a><br>and at:<br><a href="https://github.com/scipy/scipy/releases/tag/v1.4.0rc2">https://github.com/scipy/scipy/releases/tag/v1.4.0rc2</a><br><br>One of a few ways to install the release candidate with pip:<br><br>pip install scipy==1.4.0rc2<div><br>==========================<br>SciPy 1.4.0 Release Notes<br>==========================<br><br>Note: Scipy 1.4.0 is not released yet!<br><br>SciPy 1.4.0 is the culmination of 6 months of hard work. It contains<br>many new features, numerous bug-fixes, improved test coverage and better<br>documentation. There have been a number of deprecations and API changes<br>in this release, which are documented below. All users are encouraged to<br>upgrade to this release, as there are a large number of bug-fixes and<br>optimizations. Before upgrading, we recommend that users check that<br>their own code does not use deprecated SciPy functionality (to do so,<br>run your code with ``python -Wd`` and check for ``DeprecationWarning`` s).<br>Our development attention will now shift to bug-fix releases on the<br>1.4.x branch, and on adding new features on the master branch.<br><br>This release requires Python 3.5+ and NumPy >=1.13.3 (for Python 3.5, 3.6),<br>>=1.14.5 (for Python 3.7), >= 1.17.3 (for Python 3.8)<br><br>For running on PyPy, PyPy3 6.0+ and NumPy 1.15.0 are required.<br><br>Highlights of this release<br>-----------------------------------<br><br>- a new submodule, `scipy.fft`, now supersedes `scipy.fftpack`; this<br>  means support for ``long double`` transforms, faster multi-dimensional<br>  transforms, improved algorithm time complexity, release of the global<br>  intepreter lock, and control over threading behavior<br>- support for ``pydata/sparse`` arrays in `scipy.sparse.linalg`<br>- substantial improvement to the documentation and functionality of<br>  several `scipy.special` functions, and some new additions<br>- the generalized inverse Gaussian distribution has been added to<br>  `scipy.stats`<br>- an implementation of the Edmonds-Karp algorithm in<br>  `scipy.sparse.csgraph.maximum_flow`<br>- `scipy.spatial.SphericalVoronoi` now supports n-dimensional input, <br>   has linear memory complexity, improved performance, and<br>   supports single-hemisphere generators<br><br><br>New features<br>============<br><br>Infrastructure<br>--------------------<br>Documentation can now be built with ``runtests.py --doc``<br><br>A ``Dockerfile`` is now available in the ``scipy/scipy-dev`` repository to<br>facilitate getting started with SciPy development.<br><br>`scipy.constants` improvements<br>----------------------------------------------<br>`scipy.constants` has been updated with the CODATA 2018 constants.<br><br><br>`scipy.fft` added<br>-----------------------<br>`scipy.fft` is a new submodule that supersedes the `scipy.fftpack` submodule. <br>For the most part, this is a drop-in replacement for ``numpy.fft`` and <br>`scipy.fftpack` alike. With some important differences, `scipy.fft`:<br>- uses NumPy's conventions for real transforms (``rfft``). This means the <br>return value is a complex array, half the size of the full ``fft`` output.<br>This is different from the output of ``fftpack`` which returned a real array <br>representing complex components packed together.<br>- the inverse real to real transforms (``idct`` and ``idst``) are normalized <br>for ``norm=None`` in thesame way as ``ifft``. This means the identity <br>``idct(dct(x)) == x`` is now ``True`` for all norm modes.<br>- does not include the convolutions or pseudo-differential operators<br>from ``fftpack``.<br><br>This submodule is based on the ``pypocketfft`` library, developed by the <br>author of ``pocketfft`` which was recently adopted by NumPy as well.<br>``pypocketfft`` offers a number of advantages over fortran ``FFTPACK``:<br>- support for long double (``np.longfloat``) precision transforms.<br>- faster multi-dimensional transforms using vectorisation<br>- Bluestein’s algorithm removes the worst-case ``O(n^2)`` complexity of<br>``FFTPACK``<br>- the global interpreter lock (``GIL``) is released during transforms<br>- optional multithreading of multi-dimensional transforms via the ``workers``<br>argument<br><br>Note that `scipy.fftpack` has not been deprecated and will continue to be <br>maintained but is now considered legacy. New code is recommended to use <br>`scipy.fft` instead, where possible.<br><br>`scipy.fftpack` improvements<br>----------------------------------------<br>`scipy.fftpack` now uses pypocketfft to perform its FFTs, offering the same<br>speed and accuracy benefits listed for scipy.fft above but without the<br>improved API.<br><br>`scipy.integrate` improvements<br>-------------------------------------------<br><br>The function `scipy.integrate.solve_ivp` now has an ``args`` argument.<br>This allows the user-defined functions passed to the function to have<br>additional parameters without having to create wrapper functions or<br>lambda expressions for them.<br><br>`scipy.integrate.solve_ivp` can now return a ``y_events`` attribute <br>representing the solution of the ODE at event times<br><br>New ``OdeSolver`` is implemented --- ``DOP853``. This is a high-order explicit<br>Runge-Kutta method originally implemented in Fortran. Now we provide a pure <br>Python implementation usable through ``solve_ivp`` with all its features.<br><br>`scipy.integrate.quad` provides better user feedback when break points are <br>specified with a weighted integrand.<br><br>`scipy.integrate.quad_vec` is now available for general purpose integration<br>of vector-valued functions<br><br><br>`scipy.interpolate` improvements<br>--------------------------------------------<br>`scipy.interpolate.pade` now handles complex input data gracefully<br><br>`scipy.interpolate.Rbf` can now interpolate multi-dimensional functions<br><br>`<a href="http://scipy.io">scipy.io</a>` improvements<br>---------------------------------<br><br>`scipy.io.wavfile.read` can now read data from a `WAV` file that has a<br>malformed header, similar to other modern `WAV` file parsers<br><br>`scipy.io.FortranFile` now has an expanded set of available ``Exception``<br>classes for handling poorly-formatted files<br><br><br>`scipy.linalg` improvements<br>--------------------------------------<br>The function ``scipy.linalg.subspace_angles(A, B)`` now gives correct<br>results for complex-valued matrices. Before this, the function only returned<br>correct values for real-valued matrices.<br><br>New boolean keyword argument ``check_finite`` for `scipy.linalg.norm`; whether <br>to check that the input matrix contains only finite numbers. Disabling may <br>give a performance gain, but may result in problems (crashes, non-termination)<br>if the inputs do contain infinities or NaNs.<br><br>`scipy.linalg.solve_triangular` has improved performance for a C-ordered<br>triangular matrix<br><br>``LAPACK`` wrappers have been added for ``?geequ``, ``?geequb``, ``?syequb``,<br>and ``?heequb``<br><br>Some performance improvements may be observed due to an internal optimization<br>in operations involving LAPACK routines via ``_compute_lwork``. This is<br>particularly true for operations on small arrays.<br><br>Block ``QR`` wrappers are now available in `scipy.linalg.lapack`<br><br><br>`scipy.ndimage` improvements<br>------------------------------------------<br><br><br>`scipy.optimize` improvements<br>------------------------------------------<br>It is now possible to use linear and non-linear constraints with <br>`scipy.optimize.differential_evolution`.<br><br>`scipy.optimize.linear_sum_assignment` has been re-written in C++ to improve <br>performance, and now allows input costs to be infinite.<br><br>A ``ScalarFunction.fun_and_grad`` method was added for convenient simultaneous<br>retrieval of a function and gradient evaluation<br><br>`scipy.optimize.minimize` ``BFGS`` method has improved performance by avoiding<br>duplicate evaluations in some cases<br><br>Better user feedback is provided when an objective function returns an array<br>instead of a scalar.<br><br><br>`scipy.signal` improvements<br>---------------------------------------<br><br>Added a new function to calculate convolution using the overlap-add method,<br>named `scipy.signal.oaconvolve`. Like `scipy.signal.fftconvolve`, this<br>function supports specifying dimensions along which to do the convolution.<br><br>`scipy.signal.cwt` now supports complex wavelets.<br><br>The implementation of ``choose_conv_method`` has been updated to reflect the <br>new FFT implementation. In addition, the performance has been significantly <br>improved (with rather drastic improvements in edge cases).<br><br>The function ``upfirdn`` now has a ``mode`` keyword argument that can be used<br>to select the signal extension mode used at the signal boundaries. These modes<br>are also available for use in ``resample_poly`` via a newly added ``padtype``<br>argument.<br><br>`scipy.signal.sosfilt` now benefits from Cython code for improved performance<br><br>`scipy.signal.resample` should be more efficient by leveraging ``rfft`` when<br>possible<br><br>`scipy.sparse` improvements<br>----------------------------------------<br>It is now possible to use the LOBPCG method in `scipy.sparse.linalg.svds`.<br><br>`scipy.sparse.linalg.LinearOperator` now supports the operation ``rmatmat`` <br>for adjoint matrix-matrix multiplication, in addition to ``rmatvec``.<br><br>Multiple stability updates enable float32 support in the LOBPCG eigenvalue <br>solver for symmetric and Hermitian eigenvalues problems in <br>``scipy.sparse.linalg.lobpcg``.<br><br>A solver for the maximum flow problem has been added as<br>`scipy.sparse.csgraph.maximum_flow`.<br><br>`scipy.sparse.csgraph.maximum_bipartite_matching` now allows non-square inputs,<br>no longer requires a perfect matching to exist, and has improved performance.<br><br>`scipy.sparse.lil_matrix` conversions now perform better in some scenarios<br><br>Basic support is available for ``pydata/sparse`` arrays in<br>`scipy.sparse.linalg`<br><br>`scipy.sparse.linalg.spsolve_triangular` now supports the ``unit_diagonal``<br>argument to improve call signature similarity with its dense counterpart,<br>`scipy.linalg.solve_triangular`<br><br>``assertAlmostEqual`` may now be used with sparse matrices, which have added<br>support for ``__round__``<br><br>`scipy.spatial` improvements<br>--------------------------------------<br>The bundled Qhull library was upgraded to version 2019.1, fixing several<br>issues. Scipy-specific patches are no longer applied to it.<br><br>`scipy.spatial.SphericalVoronoi` now has linear memory complexity, improved<br>performance, and supports single-hemisphere generators. Support has also been<br>added for handling generators that lie on a great circle arc (geodesic input)<br>and for generators in n-dimensions.<br><br>`scipy.spatial.transform.Rotation` now includes functions for calculation of a<br>mean rotation, generation of the 3D rotation groups, and reduction of rotations<br>with rotational symmetries.<br><br>`scipy.spatial.transform.Slerp` is now callable with a scalar argument<br><br>`scipy.spatial.voronoi_plot_2d` now supports furthest site Voronoi diagrams<br><br>`scipy.spatial.Delaunay` and `scipy.spatial.Voronoi` now have attributes<br>for tracking whether they are furthest site diagrams<br><br>`scipy.special` improvements<br>---------------------------------------<br>The Voigt profile has been added as `scipy.special.voigt_profile`.<br><br>A real dispatch has been added for the Wright Omega function<br>(`scipy.special.wrightomega`).<br><br>The analytic continuation of the Riemann zeta function has been added. (The <br>Riemann zeta function is the one-argument variant of `scipy.special.zeta`.)<br><br>The complete elliptic integral of the first kind (`scipy.special.ellipk`) is <br>now available in `scipy.special.cython_special`.<br><br>The accuracy of `scipy.special.hyp1f1` for real arguments has been improved.<br><br>The documentation of many functions has been improved.<br><br>`scipy.stats` improvements<br>-------------------------------------<br>`scipy.stats.multiscale_graphcorr` added as an independence test that<br>operates on high dimensional and nonlinear data sets. It has higher statistical<br>power than other `scipy.stats` tests while being the only one that operates on<br>multivariate data.<br><br>The generalized inverse Gaussian distribution (`scipy.stats.geninvgauss`) has <br>been added.<br><br>It is now possible to efficiently reuse `scipy.stats.binned_statistic_dd` <br>with new values by providing the result of a previous call to the function.<br><br>`scipy.stats.hmean` now handles input with zeros more gracefully.<br><br>The beta-binomial distribution is now available in `scipy.stats.betabinom`.<br><br>`scipy.stats.zscore`, `scipy.stats.circmean`, `scipy.stats.circstd`, and<br>`scipy.stats.circvar` now support the ``nan_policy`` argument for enhanced<br>handling of ``NaN`` values<br><br>`scipy.stats.entropy` now accepts an ``axis`` argument<br><br>`scipy.stats.gaussian_kde.resample` now accepts a ``seed`` argument to empower<br>reproducibility<br><br>`scipy.stats.kendalltau` performance has improved, especially for large inputs,<br>due to improved cache usage<br><br>`scipy.stats.truncnorm` distribution has been rewritten to support much wider<br>tails<br><br><br>Deprecated features<br>===================<br><br>`scipy` deprecations<br>----------------------------<br>Support for NumPy functions exposed via the root SciPy namespace is deprecated<br>and will be removed in 2.0.0. For example, if you use ``scipy.rand`` or<br>``scipy.diag``, you should change your code to directly use<br>``numpy.random.default_rng`` or ``numpy.diag``, respectively.<br>They remain available in the currently continuing Scipy 1.x release series.<br><br>The exception to this rule is using ``scipy.fft`` as a function --<br>:mod:`scipy.fft` is now meant to be used only as a module, so the ability to<br>call ``scipy.fft(...)`` will be removed in SciPy 1.5.0.<br><br>In `scipy.spatial.Rotation` methods ``from_dcm``, ``as_dcm`` were renamed to <br>``from_matrix``, ``as_matrix`` respectively. The old names will be removed in <br>SciPy 1.6.0.<br><br>Method ``Rotation.match_vectors`` was deprecated in favor of <br>``Rotation.align_vectors``, which provides a more logical and <br>general API to the same functionality. The old method <br>will be removed in SciPy 1.6.0.<br><br>Backwards incompatible changes<br>==============================<br><br>`scipy.special` changes<br>--------------------------------<br>The deprecated functions ``hyp2f0``, ``hyp1f2``, and ``hyp3f0`` have been<br>removed.<br><br>The deprecated function ``bessel_diff_formula`` has been removed.<br><br>The function ``i0`` is no longer registered with ``numpy.dual``, so that <br>``numpy.dual.i0`` will unconditionally refer to the NumPy version regardless <br>of whether `scipy.special` is imported.<br><br>The function ``expn`` has been changed to return ``nan`` outside of its <br>domain of definition (``x, n < 0``) instead of ``inf``.<br><br>`scipy.sparse` changes<br>--------------------------------<br>Sparse matrix reshape now raises an error if shape is not two-dimensional, <br>rather than guessing what was meant. The behavior is now the same as before <br>SciPy 1.1.0.<br><br>``CSR`` and ``CSC`` sparse matrix classes should now return empty matrices<br>of the same type when indexed out of bounds. Previously, for some versions<br>of SciPy, this would raise an ``IndexError``. The change is largely motivated<br>by greater consistency with ``ndarray`` and ``numpy.matrix`` semantics.<br><br>`scipy.signal` changes<br>------------------------------<br>`scipy.signal.resample` behavior for length-1 signal inputs has been<br>fixed to output a constant (DC) value rather than an impulse, consistent with<br>the assumption of signal periodicity in the FFT method.<br><br>`scipy.signal.cwt` now performs complex conjugation and time-reversal of<br>wavelet data, which is a backwards-incompatible bugfix for<br>time-asymmetric wavelets.<br><br>`scipy.stats` changes<br>-----------------------------<br>`scipy.stats.loguniform` added with better documentation as (an alias for<br>``scipy.stats.reciprocal``). ``loguniform`` generates random variables<br>that are equally likely in the log space; e.g., ``1``, ``10`` and ``100``<br>are all equally likely if ``loguniform(10 ** 0, 10 ** 2).rvs()`` is used.<br><br><br>Other changes<br>=============<br>The ``LSODA`` method of `scipy.integrate.solve_ivp` now correctly detects stiff<br>problems.<br><br>`scipy.spatial.cKDTree` now accepts and correctly handles empty input data<br><br>`scipy.stats.binned_statistic_dd` now calculates the standard deviation <br>statistic in a numerically stable way.<br><br>`scipy.stats.binned_statistic_dd` now throws an error if the input data <br>contains either ``np.nan`` or ``np.inf``. Similarly, in `scipy.stats` now all <br>continuous distributions' ``.fit()`` methods throw an error if the input data<br>contain any instance of either ``np.nan`` or ``np.inf``.<br><br><br>Authors<br>=======<br><br>* @endolith<br>* @wenhui-prudencemed +<br>* Abhinav +<br>* Anne Archibald<br>* ashwinpathak20nov1996 +<br>* Danilo Augusto +<br>* Nelson Auner +<br>* aypiggott +<br>* Christoph Baumgarten<br>* Peter Bell<br>* Sebastian Berg<br>* Arman Bilge +<br>* Benedikt Boecking +<br>* Christoph Boeddeker +<br>* Daniel Bunting<br>* Evgeni Burovski<br>* Angeline Burrell +<br>* Angeline G. Burrell +<br>* CJ Carey<br>* Carlos Ramos Carreño +<br>* Mak Sze Chun +<br>* Malayaja Chutani +<br>* Christian Clauss +<br>* Jonathan Conroy +<br>* Stephen P Cook +<br>* Dylan Cutler +<br>* Anirudh Dagar +<br>* Aidan Dang +<br>* dankleeman +<br>* Brandon David +<br>* Tyler Dawson +<br>* Dieter Werthmüller<br>* Joe Driscoll +<br>* Jakub Dyczek +<br>* Dávid Bodnár<br>* Fletcher Easton +<br>* Stefan Endres<br>* etienne +<br>* Johann Faouzi<br>* Yu Feng<br>* Isuru Fernando +<br>* Matthew H Flamm<br>* Martin Gauch +<br>* Gabriel Gerlero +<br>* Ralf Gommers<br>* Chris Gorgolewski +<br>* Domen Gorjup +<br>* Edouard Goudenhoofdt +<br>* Jan Gwinner +<br>* Maja Gwozdz +<br>* Matt Haberland<br>* hadshirt +<br>* Pierre Haessig +<br>* David Hagen<br>* Charles Harris<br>* Gina Helfrich +<br>* Alex Henrie +<br>* Francisco J. Hernandez Heras +<br>* Andreas Hilboll<br>* Lindsey Hiltner<br>* Thomas Hisch<br>* Min ho Kim +<br>* Gert-Ludwig Ingold<br>* jakobjakobson13 +<br>* Todd Jennings<br>* He Jia<br>* Muhammad Firmansyah Kasim +<br>* Andrew Knyazev +<br>* Holger Kohr +<br>* Mateusz Konieczny +<br>* Krzysztof Pióro +<br>* Philipp Lang +<br>* Peter Mahler Larsen +<br>* Eric Larson<br>* Antony Lee<br>* Gregory R. Lee<br>* Chelsea Liu +<br>* Jesse Livezey<br>* Peter Lysakovski +<br>* Jason Manley +<br>* Michael Marien +<br>* Nikolay Mayorov<br>* G. D. McBain +<br>* Sam McCormack +<br>* Melissa Weber Mendonça +<br>* Kevin Michel +<br>* mikeWShef +<br>* Sturla Molden<br>* Eric Moore<br>* Peyton Murray +<br>* Andrew Nelson<br>* Clement Ng +<br>* Juan Nunez-Iglesias<br>* Renee Otten +<br>* Kellie Ottoboni +<br>* Ayappan P<br>* Sambit Panda +<br>* Tapasweni Pathak +<br>* Oleksandr Pavlyk<br>* Fabian Pedregosa<br>* Petar Mlinarić<br>* Matti Picus<br>* Marcel Plch +<br>* Christoph Pohl +<br>* Ilhan Polat<br>* Siddhesh Poyarekar +<br>* Ioannis Prapas +<br>* James Alan Preiss +<br>* Yisheng Qiu +<br>* Eric Quintero<br>* Bharat Raghunathan +<br>* Tyler Reddy<br>* Joscha Reimer<br>* Antonio Horta Ribeiro<br>* Lucas Roberts<br>* rtshort +<br>* Josua Sassen<br>* Kevin Sheppard<br>* Scott Sievert<br>* Leo Singer<br>* Kai Striega<br>* Søren Fuglede Jørgensen<br>* tborisow +<br>* Étienne Tremblay +<br>* tuxcell +<br>* Miguel de Val-Borro<br>* Andrew Valentine +<br>* Hugo van Kemenade<br>* Paul van Mulbregt<br>* Sebastiano Vigna<br>* Pauli Virtanen<br>* Dany Vohl +<br>* Ben Walsh +<br>* Huize Wang +<br>* Warren Weckesser<br>* Anreas Weh +<br>* Joseph Weston +<br>* Adrian Wijaya +<br>* Timothy Willard +<br>* Josh Wilson<br>* Kentaro Yamamoto +<br>* Dave Zbarsky +<br><br>A total of 142 people contributed to this release.<br>People with a "+" by their names contributed a patch for the first time.<br>This list of names is automatically generated, and may not be fully complete.<br><br><br>Issues closed for 1.4.0<br>--------------------------------<br><br>* `#1255 <<a href="https://github.com/scipy/scipy/issues/1255">https://github.com/scipy/scipy/issues/1255</a>>`__: maxiter broken for Scipy.sparse.linalg gmres, in addition to...<br>* `#1301 <<a href="https://github.com/scipy/scipy/issues/1301">https://github.com/scipy/scipy/issues/1301</a>>`__: consolidate multipack.h from interpolate and integrate packages...<br>* `#1739 <<a href="https://github.com/scipy/scipy/issues/1739">https://github.com/scipy/scipy/issues/1739</a>>`__: Single precision FFT insufficiently accurate. (Trac #1212)<br>* `#1795 <<a href="https://github.com/scipy/scipy/issues/1795">https://github.com/scipy/scipy/issues/1795</a>>`__: stats test_distributions.py: replace old fuzz tests (Trac #1269)<br>* `#2233 <<a href="https://github.com/scipy/scipy/issues/2233">https://github.com/scipy/scipy/issues/2233</a>>`__: fftpack segfault with big arrays (Trac #1714)<br>* `#2434 <<a href="https://github.com/scipy/scipy/issues/2434">https://github.com/scipy/scipy/issues/2434</a>>`__: rmatmat and the sophistication of linear operator objects<br>* `#2477 <<a href="https://github.com/scipy/scipy/issues/2477">https://github.com/scipy/scipy/issues/2477</a>>`__: stats.truncnorm.rvs() does not give symmetric results for negative...<br>* `#2629 <<a href="https://github.com/scipy/scipy/issues/2629">https://github.com/scipy/scipy/issues/2629</a>>`__: FFTpack is unacceptably slow on non power of 2<br>* `#2883 <<a href="https://github.com/scipy/scipy/issues/2883">https://github.com/scipy/scipy/issues/2883</a>>`__: UnboundLocalError in scipy.interpolate.splrep<br>* `#2956 <<a href="https://github.com/scipy/scipy/issues/2956">https://github.com/scipy/scipy/issues/2956</a>>`__: Feature Request: axis argument for stats.entropy function<br>* `#3528 <<a href="https://github.com/scipy/scipy/issues/3528">https://github.com/scipy/scipy/issues/3528</a>>`__: Segfault on test_djbfft (possibly MKL-related?)<br>* `#3793 <<a href="https://github.com/scipy/scipy/issues/3793">https://github.com/scipy/scipy/issues/3793</a>>`__: cwt should also return complex array<br>* `#4464 <<a href="https://github.com/scipy/scipy/issues/4464">https://github.com/scipy/scipy/issues/4464</a>>`__: TST: residue/residuez/invres/invresz don't have any tests<br>* `#4561 <<a href="https://github.com/scipy/scipy/issues/4561">https://github.com/scipy/scipy/issues/4561</a>>`__: BUG: tf filter trailing and leading zeros in residuez<br>* `#4669 <<a href="https://github.com/scipy/scipy/issues/4669">https://github.com/scipy/scipy/issues/4669</a>>`__: Rewrite sosfilt to make a single loop over the input?<br>* `#5040 <<a href="https://github.com/scipy/scipy/issues/5040">https://github.com/scipy/scipy/issues/5040</a>>`__: BUG: Empty data handling of (c)KDTrees<br>* `#5112 <<a href="https://github.com/scipy/scipy/issues/5112">https://github.com/scipy/scipy/issues/5112</a>>`__: boxcox transform edge cases could use more care<br>* `#5441 <<a href="https://github.com/scipy/scipy/issues/5441">https://github.com/scipy/scipy/issues/5441</a>>`__: scipy.stats.ncx2 fails for nc=0<br>* `#5502 <<a href="https://github.com/scipy/scipy/issues/5502">https://github.com/scipy/scipy/issues/5502</a>>`__: args keyword not handled in optimize.curve_fit<br>* `#6484 <<a href="https://github.com/scipy/scipy/issues/6484">https://github.com/scipy/scipy/issues/6484</a>>`__: Qhull segmentation fault<br>* `#6900 <<a href="https://github.com/scipy/scipy/issues/6900">https://github.com/scipy/scipy/issues/6900</a>>`__: linear_sum_assignment with infinite weights<br>* `#6966 <<a href="https://github.com/scipy/scipy/issues/6966">https://github.com/scipy/scipy/issues/6966</a>>`__: Hypergeometric Functions documentation is lacking<br>* `#6999 <<a href="https://github.com/scipy/scipy/issues/6999">https://github.com/scipy/scipy/issues/6999</a>>`__: possible false positive corruption check in compressed loadmat()<br>* `#7018 <<a href="https://github.com/scipy/scipy/issues/7018">https://github.com/scipy/scipy/issues/7018</a>>`__: ydata that needs broadcasting renders curve_fit unable to compute...<br>* `#7140 <<a href="https://github.com/scipy/scipy/issues/7140">https://github.com/scipy/scipy/issues/7140</a>>`__: trouble with documentation for windows<br>* `#7327 <<a href="https://github.com/scipy/scipy/issues/7327">https://github.com/scipy/scipy/issues/7327</a>>`__: interpolate.ndgriddata.griddata causes Python to crash rather...<br>* `#7396 <<a href="https://github.com/scipy/scipy/issues/7396">https://github.com/scipy/scipy/issues/7396</a>>`__: MatrixLinearOperator implements _adjoint(), but not _transpose()<br>* `#7400 <<a href="https://github.com/scipy/scipy/issues/7400">https://github.com/scipy/scipy/issues/7400</a>>`__: BUG(?): special: factorial and factorial2 return a 0-dimensional...<br>* `#7434 <<a href="https://github.com/scipy/scipy/issues/7434">https://github.com/scipy/scipy/issues/7434</a>>`__: Testing of scipy.stats continuous distributions misses 25 distributions<br>* `#7491 <<a href="https://github.com/scipy/scipy/issues/7491">https://github.com/scipy/scipy/issues/7491</a>>`__: Several scipy.stats distributions (fisk, burr, burr12, f) return...<br>* `#7759 <<a href="https://github.com/scipy/scipy/issues/7759">https://github.com/scipy/scipy/issues/7759</a>>`__: Overflow in stats.kruskal for large samples<br>* `#7906 <<a href="https://github.com/scipy/scipy/issues/7906">https://github.com/scipy/scipy/issues/7906</a>>`__: Wrong result from scipy.interpolate.UnivariateSpline.integral...<br>* `#8165 <<a href="https://github.com/scipy/scipy/issues/8165">https://github.com/scipy/scipy/issues/8165</a>>`__: ENH: match functionality of R for hmean<br>* `#8417 <<a href="https://github.com/scipy/scipy/issues/8417">https://github.com/scipy/scipy/issues/8417</a>>`__: optimimze.minimize(method='L-BFGS-B', options={'disp': True})...<br>* `#8535 <<a href="https://github.com/scipy/scipy/issues/8535">https://github.com/scipy/scipy/issues/8535</a>>`__: Strictly increasing requirement in UnivariateSpline<br>* `#8815 <<a href="https://github.com/scipy/scipy/issues/8815">https://github.com/scipy/scipy/issues/8815</a>>`__: [BUG] GMRES: number of iteration is only increased if callback...<br>* `#9207 <<a href="https://github.com/scipy/scipy/issues/9207">https://github.com/scipy/scipy/issues/9207</a>>`__: scipy.linalg.solve_triangular speed after scipy.linalg.lu_factor<br>* `#9275 <<a href="https://github.com/scipy/scipy/issues/9275">https://github.com/scipy/scipy/issues/9275</a>>`__: new feature: adding LOBPCG solver in svds in addition to ARPACK<br>* `#9403 <<a href="https://github.com/scipy/scipy/issues/9403">https://github.com/scipy/scipy/issues/9403</a>>`__: range of truncnorm.logpdf could be extended<br>* `#9429 <<a href="https://github.com/scipy/scipy/issues/9429">https://github.com/scipy/scipy/issues/9429</a>>`__: gaussian_kde not working with numpy matrix<br>* `#9515 <<a href="https://github.com/scipy/scipy/issues/9515">https://github.com/scipy/scipy/issues/9515</a>>`__: ndimage implementation relies on undefined behavior<br>* `#9643 <<a href="https://github.com/scipy/scipy/issues/9643">https://github.com/scipy/scipy/issues/9643</a>>`__: arpack returns singular values in ascending order<br>* `#9669 <<a href="https://github.com/scipy/scipy/issues/9669">https://github.com/scipy/scipy/issues/9669</a>>`__: DOC: matthew-brett/build-openblas has been retired<br>* `#9852 <<a href="https://github.com/scipy/scipy/issues/9852">https://github.com/scipy/scipy/issues/9852</a>>`__: scipy.spatial.ConvexHull exit with code 134, free(): invalid...<br>* `#9902 <<a href="https://github.com/scipy/scipy/issues/9902">https://github.com/scipy/scipy/issues/9902</a>>`__: scipy.stats.truncnorm second moment may be wrong<br>* `#9943 <<a href="https://github.com/scipy/scipy/issues/9943">https://github.com/scipy/scipy/issues/9943</a>>`__: Custom sampling methods in shgo do not work<br>* `#9947 <<a href="https://github.com/scipy/scipy/issues/9947">https://github.com/scipy/scipy/issues/9947</a>>`__: DOC: Incorrect documentation for \`nan_policy='propagate\` in...<br>* `#9994 <<a href="https://github.com/scipy/scipy/issues/9994">https://github.com/scipy/scipy/issues/9994</a>>`__: BUG: sparse: reshape method allows a shape containing an arbitrary...<br>* `#10036 <<a href="https://github.com/scipy/scipy/issues/10036">https://github.com/scipy/scipy/issues/10036</a>>`__: Official Nelder mead tutorial uses xtol instead of xatol, which...<br>* `#10078 <<a href="https://github.com/scipy/scipy/issues/10078">https://github.com/scipy/scipy/issues/10078</a>>`__: possible to get a better error message when objective function...<br>* `#10092 <<a href="https://github.com/scipy/scipy/issues/10092">https://github.com/scipy/scipy/issues/10092</a>>`__: overflow in truncnorm.rvs<br>* `#10121 <<a href="https://github.com/scipy/scipy/issues/10121">https://github.com/scipy/scipy/issues/10121</a>>`__: A little spelling mistake<br>* `#10126 <<a href="https://github.com/scipy/scipy/issues/10126">https://github.com/scipy/scipy/issues/10126</a>>`__: inaccurate std implementation in binned_statistic<br>* `#10161 <<a href="https://github.com/scipy/scipy/issues/10161">https://github.com/scipy/scipy/issues/10161</a>>`__: Error in documentation scipy.special.modstruve<br>* `#10195 <<a href="https://github.com/scipy/scipy/issues/10195">https://github.com/scipy/scipy/issues/10195</a>>`__: Derivative of spline with 'const' extrapolation is also extrapolted...<br>* `#10206 <<a href="https://github.com/scipy/scipy/issues/10206">https://github.com/scipy/scipy/issues/10206</a>>`__: sparse matrices indexing with scipy 1.3<br>* `#10236 <<a href="https://github.com/scipy/scipy/issues/10236">https://github.com/scipy/scipy/issues/10236</a>>`__: Non-descriptive error on type mismatch for functions of scipy.optimize...<br>* `#10258 <<a href="https://github.com/scipy/scipy/issues/10258">https://github.com/scipy/scipy/issues/10258</a>>`__: LOBPCG convergence failure if guess provided<br>* `#10262 <<a href="https://github.com/scipy/scipy/issues/10262">https://github.com/scipy/scipy/issues/10262</a>>`__: distance matrix lacks dtype checks / warnings<br>* `#10271 <<a href="https://github.com/scipy/scipy/issues/10271">https://github.com/scipy/scipy/issues/10271</a>>`__: BUG: optimize failure on wheels<br>* `#10277 <<a href="https://github.com/scipy/scipy/issues/10277">https://github.com/scipy/scipy/issues/10277</a>>`__: scipy.special.zeta(0) = NAN<br>* `#10292 <<a href="https://github.com/scipy/scipy/issues/10292">https://github.com/scipy/scipy/issues/10292</a>>`__: DOC/REL: Some sections of the release notes are not nested correctly.<br>* `#10300 <<a href="https://github.com/scipy/scipy/issues/10300">https://github.com/scipy/scipy/issues/10300</a>>`__: scipy.stats.rv_continuous.fit throws empty RuntimeError when...<br>* `#10319 <<a href="https://github.com/scipy/scipy/issues/10319">https://github.com/scipy/scipy/issues/10319</a>>`__: events in scipy.integrate.solve_ivp: How do I setup an events...<br>* `#10323 <<a href="https://github.com/scipy/scipy/issues/10323">https://github.com/scipy/scipy/issues/10323</a>>`__: Adding more low-level LAPACK wrappers<br>* `#10360 <<a href="https://github.com/scipy/scipy/issues/10360">https://github.com/scipy/scipy/issues/10360</a>>`__: firwin2 inadvertently modifies input and may result in undefined...<br>* `#10388 <<a href="https://github.com/scipy/scipy/issues/10388">https://github.com/scipy/scipy/issues/10388</a>>`__: BLD: TestHerd::test_hetrd core dumps with Python-dbg<br>* `#10395 <<a href="https://github.com/scipy/scipy/issues/10395">https://github.com/scipy/scipy/issues/10395</a>>`__: Remove warning about output shape of zoom<br>* `#10403 <<a href="https://github.com/scipy/scipy/issues/10403">https://github.com/scipy/scipy/issues/10403</a>>`__: DOC: scipy.signal.resample ignores t parameter<br>* `#10421 <<a href="https://github.com/scipy/scipy/issues/10421">https://github.com/scipy/scipy/issues/10421</a>>`__: Yeo-Johnson power transformation fails with integer input data<br>* `#10422 <<a href="https://github.com/scipy/scipy/issues/10422">https://github.com/scipy/scipy/issues/10422</a>>`__: BUG: scipy.fft does not support multiprocessing<br>* `#10427 <<a href="https://github.com/scipy/scipy/issues/10427">https://github.com/scipy/scipy/issues/10427</a>>`__: ENH: convolve numbers should be updated<br>* `#10444 <<a href="https://github.com/scipy/scipy/issues/10444">https://github.com/scipy/scipy/issues/10444</a>>`__: BUG: scipy.spatial.transform.Rotation.match_vectors returns improper...<br>* `#10488 <<a href="https://github.com/scipy/scipy/issues/10488">https://github.com/scipy/scipy/issues/10488</a>>`__: ENH: DCTs/DSTs for scipy.fft<br>* `#10501 <<a href="https://github.com/scipy/scipy/issues/10501">https://github.com/scipy/scipy/issues/10501</a>>`__: BUG: scipy.spatial.HalfspaceIntersection works incorrectly<br>* `#10514 <<a href="https://github.com/scipy/scipy/issues/10514">https://github.com/scipy/scipy/issues/10514</a>>`__: BUG: cKDTree GIL handling is incorrect<br>* `#10535 <<a href="https://github.com/scipy/scipy/issues/10535">https://github.com/scipy/scipy/issues/10535</a>>`__: TST: master branch CI failures<br>* `#10588 <<a href="https://github.com/scipy/scipy/issues/10588">https://github.com/scipy/scipy/issues/10588</a>>`__: scipy.fft and numpy.fft inconsistency when axes=None and shape...<br>* `#10628 <<a href="https://github.com/scipy/scipy/issues/10628">https://github.com/scipy/scipy/issues/10628</a>>`__: Scipy python>3.6 Windows wheels don't ship msvcp\*.dll<br>* `#10733 <<a href="https://github.com/scipy/scipy/issues/10733">https://github.com/scipy/scipy/issues/10733</a>>`__: DOC/BUG: min_only result does not match documentation<br>* `#10774 <<a href="https://github.com/scipy/scipy/issues/10774">https://github.com/scipy/scipy/issues/10774</a>>`__: min_only=true djisktra infinite loop with duplicate indices<br>* `#10775 <<a href="https://github.com/scipy/scipy/issues/10775">https://github.com/scipy/scipy/issues/10775</a>>`__: UnboundLocalError in Radau when given a NaN<br>* `#10835 <<a href="https://github.com/scipy/scipy/issues/10835">https://github.com/scipy/scipy/issues/10835</a>>`__: io.wavfile.read unnecessarily raises an error for a bad wav header<br>* `#10838 <<a href="https://github.com/scipy/scipy/issues/10838">https://github.com/scipy/scipy/issues/10838</a>>`__: Error in documentation for scipy.linalg.lu_factor<br>* `#10875 <<a href="https://github.com/scipy/scipy/issues/10875">https://github.com/scipy/scipy/issues/10875</a>>`__: DOC: Graphical guides (using TikZ)<br>* `#10880 <<a href="https://github.com/scipy/scipy/issues/10880">https://github.com/scipy/scipy/issues/10880</a>>`__: setting verbose > 2 in minimize with trust-constr method leads...<br>* `#10887 <<a href="https://github.com/scipy/scipy/issues/10887">https://github.com/scipy/scipy/issues/10887</a>>`__: scipy.signal.signaltools._fftconv_faster has incorrect estimates<br>* `#10948 <<a href="https://github.com/scipy/scipy/issues/10948">https://github.com/scipy/scipy/issues/10948</a>>`__: gammainc(0,x) = nan but should be 1, gammaincc(0,x) = nan but...<br>* `#10952 <<a href="https://github.com/scipy/scipy/issues/10952">https://github.com/scipy/scipy/issues/10952</a>>`__: TestQRdelete_F.test_delete_last_p_col test failure<br>* `#10968 <<a href="https://github.com/scipy/scipy/issues/10968">https://github.com/scipy/scipy/issues/10968</a>>`__: API: Change normalized=False to normalize=True in Rotation<br>* `#10987 <<a href="https://github.com/scipy/scipy/issues/10987">https://github.com/scipy/scipy/issues/10987</a>>`__: Memory leak in shgo triangulation<br>* `#10991 <<a href="https://github.com/scipy/scipy/issues/10991">https://github.com/scipy/scipy/issues/10991</a>>`__: Error running openBlas probably missing a step<br>* `#11033 <<a href="https://github.com/scipy/scipy/issues/11033">https://github.com/scipy/scipy/issues/11033</a>>`__: deadlock on osx for python 3.8<br>* `#11041 <<a href="https://github.com/scipy/scipy/issues/11041">https://github.com/scipy/scipy/issues/11041</a>>`__: Test failure in wheel builds for TestTf2zpk.test_simple<br>* `#11089 <<a href="https://github.com/scipy/scipy/issues/11089">https://github.com/scipy/scipy/issues/11089</a>>`__: Regression in scipy.stats where distribution will not accept loc and scale parameters<br>* `#11100 <<a href="https://github.com/scipy/scipy/issues/11100">https://github.com/scipy/scipy/issues/11100</a>>`__: BUG: multiscale_graphcorr random state seeding and parallel use<br>* `#11121 <<a href="https://github.com/scipy/scipy/issues/11121">https://github.com/scipy/scipy/issues/11121</a>>`__: Calls to `scipy.interpolate.splprep` increase RAM usage.<br>* `#11125 <<a href="https://github.com/scipy/scipy/issues/11125">https://github.com/scipy/scipy/issues/11125</a>>`__: BUG: segfault when slicing a CSR or CSC sparse matrix with slice start index > stop index<br><br>Pull requests for 1.4.0<br>-------------------------------<br><br>* `#4591 <<a href="https://github.com/scipy/scipy/pull/4591">https://github.com/scipy/scipy/pull/4591</a>>`__: BUG, TST: Several issues with scipy.signal.residue<br>* `#6629 <<a href="https://github.com/scipy/scipy/pull/6629">https://github.com/scipy/scipy/pull/6629</a>>`__: ENH: sparse: canonicalize on initialization<br>* `#7076 <<a href="https://github.com/scipy/scipy/pull/7076">https://github.com/scipy/scipy/pull/7076</a>>`__: ENH: add complex wavelet support to scipy.signal.cwt.<br>* `#8681 <<a href="https://github.com/scipy/scipy/pull/8681">https://github.com/scipy/scipy/pull/8681</a>>`__: ENH add generalized inverse Gaussian distribution to scipy.stats<br>* `#9064 <<a href="https://github.com/scipy/scipy/pull/9064">https://github.com/scipy/scipy/pull/9064</a>>`__: BUG/ENH: Added default _transpose into LinearOperator. Fixes...<br>* `#9215 <<a href="https://github.com/scipy/scipy/pull/9215">https://github.com/scipy/scipy/pull/9215</a>>`__: ENH: Rbf interpolation of large multi-dimensional data<br>* `#9311 <<a href="https://github.com/scipy/scipy/pull/9311">https://github.com/scipy/scipy/pull/9311</a>>`__: ENH: Added voigt in scipy.special.<br>* `#9642 <<a href="https://github.com/scipy/scipy/pull/9642">https://github.com/scipy/scipy/pull/9642</a>>`__: ENH: integrate: quad() for vector-valued functions<br>* `#9679 <<a href="https://github.com/scipy/scipy/pull/9679">https://github.com/scipy/scipy/pull/9679</a>>`__: DOC: expand docstring of exponweib distribution<br>* `#9684 <<a href="https://github.com/scipy/scipy/pull/9684">https://github.com/scipy/scipy/pull/9684</a>>`__: TST: add ppc64le ci testing<br>* `#9800 <<a href="https://github.com/scipy/scipy/pull/9800">https://github.com/scipy/scipy/pull/9800</a>>`__: WIP : ENH: Refactored _hungarian.py for speed and added a minimize/maximize…<br>* `#9847 <<a href="https://github.com/scipy/scipy/pull/9847">https://github.com/scipy/scipy/pull/9847</a>>`__: DOC: Change integrate tutorial to use solve_ivp instead of odeint<br>* `#9876 <<a href="https://github.com/scipy/scipy/pull/9876">https://github.com/scipy/scipy/pull/9876</a>>`__: ENH: Use rfft when possible in resampling<br>* `#9998 <<a href="https://github.com/scipy/scipy/pull/9998">https://github.com/scipy/scipy/pull/9998</a>>`__: BUG: Do not remove 1s when calling sparse: reshape method #9994<br>* `#10002 <<a href="https://github.com/scipy/scipy/pull/10002">https://github.com/scipy/scipy/pull/10002</a>>`__: ENH: adds constraints for differential evolution<br>* `#10098 <<a href="https://github.com/scipy/scipy/pull/10098">https://github.com/scipy/scipy/pull/10098</a>>`__: ENH: integrate: add args argument to solve_ivp.<br>* `#10099 <<a href="https://github.com/scipy/scipy/pull/10099">https://github.com/scipy/scipy/pull/10099</a>>`__: DOC: Add missing docs for linprog unknown_options<br>* `#10104 <<a href="https://github.com/scipy/scipy/pull/10104">https://github.com/scipy/scipy/pull/10104</a>>`__: BUG: Rewrite of stats.truncnorm distribution.<br>* `#10105 <<a href="https://github.com/scipy/scipy/pull/10105">https://github.com/scipy/scipy/pull/10105</a>>`__: MAINT improve efficiency of rvs_ratio_uniforms in scipy.stats<br>* `#10107 <<a href="https://github.com/scipy/scipy/pull/10107">https://github.com/scipy/scipy/pull/10107</a>>`__: TST: dual_annealing set seed<br>* `#10108 <<a href="https://github.com/scipy/scipy/pull/10108">https://github.com/scipy/scipy/pull/10108</a>>`__: ENH: stats: improve kendall_tau cache usage<br>* `#10110 <<a href="https://github.com/scipy/scipy/pull/10110">https://github.com/scipy/scipy/pull/10110</a>>`__: MAINT: _lib: Fix a build warning.<br>* `#10114 <<a href="https://github.com/scipy/scipy/pull/10114">https://github.com/scipy/scipy/pull/10114</a>>`__: FIX: only print bounds when supported by minimizer (shgo)<br>* `#10115 <<a href="https://github.com/scipy/scipy/pull/10115">https://github.com/scipy/scipy/pull/10115</a>>`__: TST: Add a test with an almost singular design matrix for lsq_linear<br>* `#10118 <<a href="https://github.com/scipy/scipy/pull/10118">https://github.com/scipy/scipy/pull/10118</a>>`__: MAINT: fix rdist methods in scipy.stats<br>* `#10119 <<a href="https://github.com/scipy/scipy/pull/10119">https://github.com/scipy/scipy/pull/10119</a>>`__: MAINT: improve rvs of randint in scipy.stats<br>* `#10127 <<a href="https://github.com/scipy/scipy/pull/10127">https://github.com/scipy/scipy/pull/10127</a>>`__: Fix typo in record array field name (spatial-ckdtree-sparse_distance…<br>* `#10130 <<a href="https://github.com/scipy/scipy/pull/10130">https://github.com/scipy/scipy/pull/10130</a>>`__: MAINT: ndimage: Fix some compiler warnings.<br>* `#10131 <<a href="https://github.com/scipy/scipy/pull/10131">https://github.com/scipy/scipy/pull/10131</a>>`__: DOC: Note the solve_ivp args enhancement in the 1.4.0 release...<br>* `#10133 <<a href="https://github.com/scipy/scipy/pull/10133">https://github.com/scipy/scipy/pull/10133</a>>`__: MAINT: add rvs for semicircular in scipy.stats<br>* `#10138 <<a href="https://github.com/scipy/scipy/pull/10138">https://github.com/scipy/scipy/pull/10138</a>>`__: BUG: special: Invalid arguments to ellip_harm can crash Python.<br>* `#10139 <<a href="https://github.com/scipy/scipy/pull/10139">https://github.com/scipy/scipy/pull/10139</a>>`__: MAINT: spatial: Fix some compiler warnings in the file distance_wrap.c.<br>* `#10140 <<a href="https://github.com/scipy/scipy/pull/10140">https://github.com/scipy/scipy/pull/10140</a>>`__: ENH: add handling of NaN in RuntimeWarning except clause<br>* `#10142 <<a href="https://github.com/scipy/scipy/pull/10142">https://github.com/scipy/scipy/pull/10142</a>>`__: DOC: return value of scipy.special.comb<br>* `#10143 <<a href="https://github.com/scipy/scipy/pull/10143">https://github.com/scipy/scipy/pull/10143</a>>`__: MAINT: Loosen linprog tol<br>* `#10152 <<a href="https://github.com/scipy/scipy/pull/10152">https://github.com/scipy/scipy/pull/10152</a>>`__: BUG: Fix custom sampling input for shgo, add unittest<br>* `#10154 <<a href="https://github.com/scipy/scipy/pull/10154">https://github.com/scipy/scipy/pull/10154</a>>`__: MAINT: add moments and improve doc of mielke in scipy.stats<br>* `#10158 <<a href="https://github.com/scipy/scipy/pull/10158">https://github.com/scipy/scipy/pull/10158</a>>`__: Issue #6999: read zlib checksum before checking bytes read.<br>* `#10166 <<a href="https://github.com/scipy/scipy/pull/10166">https://github.com/scipy/scipy/pull/10166</a>>`__: BUG: Correctly handle broadcasted ydata in curve_fit pcov computation.<br>* `#10167 <<a href="https://github.com/scipy/scipy/pull/10167">https://github.com/scipy/scipy/pull/10167</a>>`__: DOC: special: Add missing factor of \`i\` to \`modstruve\` docstring<br>* `#10168 <<a href="https://github.com/scipy/scipy/pull/10168">https://github.com/scipy/scipy/pull/10168</a>>`__: MAINT: stats: Fix an incorrect comment.<br>* `#10169 <<a href="https://github.com/scipy/scipy/pull/10169">https://github.com/scipy/scipy/pull/10169</a>>`__: ENH: optimize: Clarify error when objective function returns...<br>* `#10172 <<a href="https://github.com/scipy/scipy/pull/10172">https://github.com/scipy/scipy/pull/10172</a>>`__: DEV: Run tests in parallel when --parallel flag is passed to...<br>* `#10173 <<a href="https://github.com/scipy/scipy/pull/10173">https://github.com/scipy/scipy/pull/10173</a>>`__: ENH: Implement DOP853 ODE integrator<br>* `#10176 <<a href="https://github.com/scipy/scipy/pull/10176">https://github.com/scipy/scipy/pull/10176</a>>`__: Fixed typo<br>* `#10182 <<a href="https://github.com/scipy/scipy/pull/10182">https://github.com/scipy/scipy/pull/10182</a>>`__: TST: fix test issue for stats.pearsonr<br>* `#10184 <<a href="https://github.com/scipy/scipy/pull/10184">https://github.com/scipy/scipy/pull/10184</a>>`__: MAINT: stats: Simplify zmap and zscore (we can use keepdims now).<br>* `#10191 <<a href="https://github.com/scipy/scipy/pull/10191">https://github.com/scipy/scipy/pull/10191</a>>`__: DOC: fix a formatting issue in the scipy.spatial module docstring.<br>* `#10193 <<a href="https://github.com/scipy/scipy/pull/10193">https://github.com/scipy/scipy/pull/10193</a>>`__: DOC: Updated docstring for optimize.nnls<br>* `#10198 <<a href="https://github.com/scipy/scipy/pull/10198">https://github.com/scipy/scipy/pull/10198</a>>`__: DOC, ENH: special: Make \`hyp2f1\` references more specific<br>* `#10202 <<a href="https://github.com/scipy/scipy/pull/10202">https://github.com/scipy/scipy/pull/10202</a>>`__: DOC: Format DST and DCT definitions as latex equations<br>* `#10207 <<a href="https://github.com/scipy/scipy/pull/10207">https://github.com/scipy/scipy/pull/10207</a>>`__: BUG: Compressed matrix indexing should return a scalar<br>* `#10210 <<a href="https://github.com/scipy/scipy/pull/10210">https://github.com/scipy/scipy/pull/10210</a>>`__: DOC: Update docs for connection='weak' in connected_components<br>* `#10225 <<a href="https://github.com/scipy/scipy/pull/10225">https://github.com/scipy/scipy/pull/10225</a>>`__: DOC: Clarify new interfaces for legacy functions in 'optimize'<br>* `#10231 <<a href="https://github.com/scipy/scipy/pull/10231">https://github.com/scipy/scipy/pull/10231</a>>`__: DOC, MAINT: gpg2 updates to release docs / pavement<br>* `#10235 <<a href="https://github.com/scipy/scipy/pull/10235">https://github.com/scipy/scipy/pull/10235</a>>`__: LICENSE: split license file in standard BSD 3-clause and bundled.<br>* `#10238 <<a href="https://github.com/scipy/scipy/pull/10238">https://github.com/scipy/scipy/pull/10238</a>>`__: ENH: Add new scipy.fft module using pocketfft<br>* `#10243 <<a href="https://github.com/scipy/scipy/pull/10243">https://github.com/scipy/scipy/pull/10243</a>>`__: BUG: fix ARFF reader regression with quoted values.<br>* `#10248 <<a href="https://github.com/scipy/scipy/pull/10248">https://github.com/scipy/scipy/pull/10248</a>>`__: DOC: update README file<br>* `#10255 <<a href="https://github.com/scipy/scipy/pull/10255">https://github.com/scipy/scipy/pull/10255</a>>`__: CI: bump OpenBLAS to match wheels<br>* `#10264 <<a href="https://github.com/scipy/scipy/pull/10264">https://github.com/scipy/scipy/pull/10264</a>>`__: TST: add tests for stats.tvar with unflattened arrays<br>* `#10280 <<a href="https://github.com/scipy/scipy/pull/10280">https://github.com/scipy/scipy/pull/10280</a>>`__: MAINT: stats: Use a constant value for sqrt(2/PI).<br>* `#10286 <<a href="https://github.com/scipy/scipy/pull/10286">https://github.com/scipy/scipy/pull/10286</a>>`__: Development Documentation Overhaul<br>* `#10290 <<a href="https://github.com/scipy/scipy/pull/10290">https://github.com/scipy/scipy/pull/10290</a>>`__: MAINT: Deprecate NumPy functions in SciPy root<br>* `#10291 <<a href="https://github.com/scipy/scipy/pull/10291">https://github.com/scipy/scipy/pull/10291</a>>`__: FIX: Avoid importing xdist when checking for availability<br>* `#10295 <<a href="https://github.com/scipy/scipy/pull/10295">https://github.com/scipy/scipy/pull/10295</a>>`__: Disable deprecated Numpy API in __odrpack.c<br>* `#10296 <<a href="https://github.com/scipy/scipy/pull/10296">https://github.com/scipy/scipy/pull/10296</a>>`__: ENH: C++ extension for linear assignment problem<br>* `#10298 <<a href="https://github.com/scipy/scipy/pull/10298">https://github.com/scipy/scipy/pull/10298</a>>`__: ENH: Made pade function work with complex inputs<br>* `#10301 <<a href="https://github.com/scipy/scipy/pull/10301">https://github.com/scipy/scipy/pull/10301</a>>`__: DOC: Fix critical value significance levels in stats.anderson_ksamp<br>* `#10307 <<a href="https://github.com/scipy/scipy/pull/10307">https://github.com/scipy/scipy/pull/10307</a>>`__: Minkowski Distance Type Fix (issue #10262)<br>* `#10309 <<a href="https://github.com/scipy/scipy/pull/10309">https://github.com/scipy/scipy/pull/10309</a>>`__: BUG: Pass jac=None directly to lsoda<br>* `#10310 <<a href="https://github.com/scipy/scipy/pull/10310">https://github.com/scipy/scipy/pull/10310</a>>`__: BUG: interpolate: UnivariateSpline.derivative.ext is 'zeros'...<br>* `#10312 <<a href="https://github.com/scipy/scipy/pull/10312">https://github.com/scipy/scipy/pull/10312</a>>`__: FIX: Fixing a typo in a comment<br>* `#10314 <<a href="https://github.com/scipy/scipy/pull/10314">https://github.com/scipy/scipy/pull/10314</a>>`__: scipy.spatial enhancement request<br>* `#10315 <<a href="https://github.com/scipy/scipy/pull/10315">https://github.com/scipy/scipy/pull/10315</a>>`__: DOC: Update integration tutorial to solve_ivp<br>* `#10318 <<a href="https://github.com/scipy/scipy/pull/10318">https://github.com/scipy/scipy/pull/10318</a>>`__: DOC: update the example for PPoly.solve<br>* `#10333 <<a href="https://github.com/scipy/scipy/pull/10333">https://github.com/scipy/scipy/pull/10333</a>>`__: TST: add tests for stats.tvar with unflattened arrays<br>* `#10334 <<a href="https://github.com/scipy/scipy/pull/10334">https://github.com/scipy/scipy/pull/10334</a>>`__: MAINT: special: Remove deprecated \`hyp2f0\`, \`hyp1f2\`, and...<br>* `#10336 <<a href="https://github.com/scipy/scipy/pull/10336">https://github.com/scipy/scipy/pull/10336</a>>`__: BUG: linalg/interpolative: fix interp_decomp modifying input<br>* `#10341 <<a href="https://github.com/scipy/scipy/pull/10341">https://github.com/scipy/scipy/pull/10341</a>>`__: BUG: sparse.linalg/gmres: deprecate effect of callback on semantics...<br>* `#10344 <<a href="https://github.com/scipy/scipy/pull/10344">https://github.com/scipy/scipy/pull/10344</a>>`__: DOC: improve wording of mathematical formulation<br>* `#10345 <<a href="https://github.com/scipy/scipy/pull/10345">https://github.com/scipy/scipy/pull/10345</a>>`__: ENH: Tiled QR wrappers for scipy.linalg.lapack<br>* `#10350 <<a href="https://github.com/scipy/scipy/pull/10350">https://github.com/scipy/scipy/pull/10350</a>>`__: MAINT: linalg: Use the new fft subpackage in linalg.dft test...<br>* `#10351 <<a href="https://github.com/scipy/scipy/pull/10351">https://github.com/scipy/scipy/pull/10351</a>>`__: BUG: Fix unstable standard deviation calculation in histogram<br>* `#10353 <<a href="https://github.com/scipy/scipy/pull/10353">https://github.com/scipy/scipy/pull/10353</a>>`__: Bug: interpolate.NearestNDInterpolator (issue #10352)<br>* `#10357 <<a href="https://github.com/scipy/scipy/pull/10357">https://github.com/scipy/scipy/pull/10357</a>>`__: DOC: linalg: Refer to scipy.fft.fft (not fftpack) in the dft...<br>* `#10359 <<a href="https://github.com/scipy/scipy/pull/10359">https://github.com/scipy/scipy/pull/10359</a>>`__: DOC: Update roadmap now scipy.fft has been merged<br>* `#10361 <<a href="https://github.com/scipy/scipy/pull/10361">https://github.com/scipy/scipy/pull/10361</a>>`__: ENH: Prefer scipy.fft to scipy.fftpack in scipy.signal<br>* `#10371 <<a href="https://github.com/scipy/scipy/pull/10371">https://github.com/scipy/scipy/pull/10371</a>>`__: DOC: Tweaks to fft documentation<br>* `#10372 <<a href="https://github.com/scipy/scipy/pull/10372">https://github.com/scipy/scipy/pull/10372</a>>`__: DOC: Fix typos<br>* `#10377 <<a href="https://github.com/scipy/scipy/pull/10377">https://github.com/scipy/scipy/pull/10377</a>>`__: TST, MAINT: adjustments for pytest 5.0<br>* `#10378 <<a href="https://github.com/scipy/scipy/pull/10378">https://github.com/scipy/scipy/pull/10378</a>>`__: ENH: _lib: allow new np.random.Generator in check_random_state<br>* `#10379 <<a href="https://github.com/scipy/scipy/pull/10379">https://github.com/scipy/scipy/pull/10379</a>>`__: BUG: sparse: set writeability to be forward-compatible with numpy>=1.17<br>* `#10381 <<a href="https://github.com/scipy/scipy/pull/10381">https://github.com/scipy/scipy/pull/10381</a>>`__: BUG: Fixes gh-7491, pdf at x=0 of fisk/burr/burr12/f distributions.<br>* `#10387 <<a href="https://github.com/scipy/scipy/pull/10387">https://github.com/scipy/scipy/pull/10387</a>>`__: ENH: optimize/bfgs: don't evaluate twice at initial point for...<br>* `#10392 <<a href="https://github.com/scipy/scipy/pull/10392">https://github.com/scipy/scipy/pull/10392</a>>`__: [DOC] Add an example for _binned_statistic_dd<br>* `#10396 <<a href="https://github.com/scipy/scipy/pull/10396">https://github.com/scipy/scipy/pull/10396</a>>`__: Remove warning about output shape of zoom<br>* `#10397 <<a href="https://github.com/scipy/scipy/pull/10397">https://github.com/scipy/scipy/pull/10397</a>>`__: ENH: Add check_finite to sp.linalg.norm<br>* `#10399 <<a href="https://github.com/scipy/scipy/pull/10399">https://github.com/scipy/scipy/pull/10399</a>>`__: ENH: Add __round__ method to sparse matrix<br>* `#10407 <<a href="https://github.com/scipy/scipy/pull/10407">https://github.com/scipy/scipy/pull/10407</a>>`__: MAINT: drop pybind11 from install_requires, it's only build-time...<br>* `#10408 <<a href="https://github.com/scipy/scipy/pull/10408">https://github.com/scipy/scipy/pull/10408</a>>`__: TST: use pytest.raises, not numpy assert_raises<br>* `#10409 <<a href="https://github.com/scipy/scipy/pull/10409">https://github.com/scipy/scipy/pull/10409</a>>`__: CI: uninstall nose on Travis<br>* `#10410 <<a href="https://github.com/scipy/scipy/pull/10410">https://github.com/scipy/scipy/pull/10410</a>>`__: [ENH] ncx2 dispatch to chi2 when nc=0<br>* `#10411 <<a href="https://github.com/scipy/scipy/pull/10411">https://github.com/scipy/scipy/pull/10411</a>>`__: TST: optimize: test should use assert_allclose for fp comparisons<br>* `#10414 <<a href="https://github.com/scipy/scipy/pull/10414">https://github.com/scipy/scipy/pull/10414</a>>`__: DOC: add pybind11 to the other part of quickstart guides<br>* `#10417 <<a href="https://github.com/scipy/scipy/pull/10417">https://github.com/scipy/scipy/pull/10417</a>>`__: DOC: special: don't mark non-ufuncs with a \`[+]\`<br>* `#10423 <<a href="https://github.com/scipy/scipy/pull/10423">https://github.com/scipy/scipy/pull/10423</a>>`__: FIX: Use pybind11::isinstace to check array dtypes<br>* `#10424 <<a href="https://github.com/scipy/scipy/pull/10424">https://github.com/scipy/scipy/pull/10424</a>>`__: DOC: add doctest example for binary data for ttest_ind_from_stats<br>* `#10425 <<a href="https://github.com/scipy/scipy/pull/10425">https://github.com/scipy/scipy/pull/10425</a>>`__: ENH: Add missing Hermitian transforms to scipy.fft<br>* `#10426 <<a href="https://github.com/scipy/scipy/pull/10426">https://github.com/scipy/scipy/pull/10426</a>>`__: MAINT: Fix doc build bugs<br>* `#10431 <<a href="https://github.com/scipy/scipy/pull/10431">https://github.com/scipy/scipy/pull/10431</a>>`__: Update numpy version for AIX<br>* `#10433 <<a href="https://github.com/scipy/scipy/pull/10433">https://github.com/scipy/scipy/pull/10433</a>>`__: MAINT: Minor fixes for the stats<br>* `#10434 <<a href="https://github.com/scipy/scipy/pull/10434">https://github.com/scipy/scipy/pull/10434</a>>`__: BUG: special: make \`ndtri\` return NaN outside domain of definition<br>* `#10435 <<a href="https://github.com/scipy/scipy/pull/10435">https://github.com/scipy/scipy/pull/10435</a>>`__: BUG: Allow integer input data in scipy.stats.yeojohnson<br>* `#10438 <<a href="https://github.com/scipy/scipy/pull/10438">https://github.com/scipy/scipy/pull/10438</a>>`__: [DOC] Add example for kurtosis<br>* `#10440 <<a href="https://github.com/scipy/scipy/pull/10440">https://github.com/scipy/scipy/pull/10440</a>>`__: ENH: special: make \`ellipk\` a ufunc<br>* `#10443 <<a href="https://github.com/scipy/scipy/pull/10443">https://github.com/scipy/scipy/pull/10443</a>>`__: MAINT: ndimage: malloc fail check<br>* `#10447 <<a href="https://github.com/scipy/scipy/pull/10447">https://github.com/scipy/scipy/pull/10447</a>>`__: BLD: Divert output from test compiles into a temporary directory<br>* `#10451 <<a href="https://github.com/scipy/scipy/pull/10451">https://github.com/scipy/scipy/pull/10451</a>>`__: MAINT: signal: malloc fail check<br>* `#10455 <<a href="https://github.com/scipy/scipy/pull/10455">https://github.com/scipy/scipy/pull/10455</a>>`__: BUG: special: fix values of \`hyperu\` for negative \`x\`<br>* `#10456 <<a href="https://github.com/scipy/scipy/pull/10456">https://github.com/scipy/scipy/pull/10456</a>>`__: DOC: Added comment clarifying the call for dcsrch.f in lbfgsb.f<br>* `#10457 <<a href="https://github.com/scipy/scipy/pull/10457">https://github.com/scipy/scipy/pull/10457</a>>`__: BUG: Allow ckdtree to accept empty data input<br>* `#10459 <<a href="https://github.com/scipy/scipy/pull/10459">https://github.com/scipy/scipy/pull/10459</a>>`__: BUG:TST: Compute lwork safely<br>* `#10460 <<a href="https://github.com/scipy/scipy/pull/10460">https://github.com/scipy/scipy/pull/10460</a>>`__: [DOC] Add example to entropy<br>* `#10461 <<a href="https://github.com/scipy/scipy/pull/10461">https://github.com/scipy/scipy/pull/10461</a>>`__: DOC: Quickstart Guide updates<br>* `#10462 <<a href="https://github.com/scipy/scipy/pull/10462">https://github.com/scipy/scipy/pull/10462</a>>`__: TST: special: only show max atol/rtol for test points that failed<br>* `#10465 <<a href="https://github.com/scipy/scipy/pull/10465">https://github.com/scipy/scipy/pull/10465</a>>`__: BUG: Correctly align fft inputs<br>* `#10467 <<a href="https://github.com/scipy/scipy/pull/10467">https://github.com/scipy/scipy/pull/10467</a>>`__: ENH: lower-memory duplicate generator checking in spatial.SphericalVoronoi<br>* `#10470 <<a href="https://github.com/scipy/scipy/pull/10470">https://github.com/scipy/scipy/pull/10470</a>>`__: ENH: Normalise the inverse DCT/DST in scipy.fft<br>* `#10472 <<a href="https://github.com/scipy/scipy/pull/10472">https://github.com/scipy/scipy/pull/10472</a>>`__: BENCH: adjust timeout for slow setup_cache<br>* `#10475 <<a href="https://github.com/scipy/scipy/pull/10475">https://github.com/scipy/scipy/pull/10475</a>>`__: CI: include python debug for Travis-ci<br>* `#10476 <<a href="https://github.com/scipy/scipy/pull/10476">https://github.com/scipy/scipy/pull/10476</a>>`__: TST: special: use \`__tracebackhide__\` to get better error messages<br>* `#10477 <<a href="https://github.com/scipy/scipy/pull/10477">https://github.com/scipy/scipy/pull/10477</a>>`__: ENH: faster region building in spatial.SphericalVoronoi<br>* `#10479 <<a href="https://github.com/scipy/scipy/pull/10479">https://github.com/scipy/scipy/pull/10479</a>>`__: BUG: stats: Fix a few issues with the distributions' fit method.<br>* `#10480 <<a href="https://github.com/scipy/scipy/pull/10480">https://github.com/scipy/scipy/pull/10480</a>>`__: Add RuntimeError in _distn_infrastructure.py in fit() method<br>* `#10481 <<a href="https://github.com/scipy/scipy/pull/10481">https://github.com/scipy/scipy/pull/10481</a>>`__: BENCH, MAINT: wheel_cache_size has been renamed build_cache_size<br>* `#10494 <<a href="https://github.com/scipy/scipy/pull/10494">https://github.com/scipy/scipy/pull/10494</a>>`__: ENH: faster circumcenter calculation in spatial.SphericalVoronoi<br>* `#10500 <<a href="https://github.com/scipy/scipy/pull/10500">https://github.com/scipy/scipy/pull/10500</a>>`__: Splrep _curfit_cache global variable bugfix<br>* `#10503 <<a href="https://github.com/scipy/scipy/pull/10503">https://github.com/scipy/scipy/pull/10503</a>>`__: BUG: spatial/qhull: get HalfspaceIntersection.dual_points from...<br>* `#10506 <<a href="https://github.com/scipy/scipy/pull/10506">https://github.com/scipy/scipy/pull/10506</a>>`__: DOC: interp2d, note nearest neighbor extrapolation<br>* `#10507 <<a href="https://github.com/scipy/scipy/pull/10507">https://github.com/scipy/scipy/pull/10507</a>>`__: MAINT: Remove fortran fftpack library in favour of pypocketfft<br>* `#10508 <<a href="https://github.com/scipy/scipy/pull/10508">https://github.com/scipy/scipy/pull/10508</a>>`__: TST: fix a bug in the circular import test.<br>* `#10509 <<a href="https://github.com/scipy/scipy/pull/10509">https://github.com/scipy/scipy/pull/10509</a>>`__: MAINT: Set up _build_utils as subpackage<br>* `#10516 <<a href="https://github.com/scipy/scipy/pull/10516">https://github.com/scipy/scipy/pull/10516</a>>`__: BUG: Use nogil contexts in cKDTree<br>* `#10517 <<a href="https://github.com/scipy/scipy/pull/10517">https://github.com/scipy/scipy/pull/10517</a>>`__: ENH: fftconvolve should not FFT broadcastable axes<br>* `#10518 <<a href="https://github.com/scipy/scipy/pull/10518">https://github.com/scipy/scipy/pull/10518</a>>`__: ENH: Speedup fftconvolve<br>* `#10520 <<a href="https://github.com/scipy/scipy/pull/10520">https://github.com/scipy/scipy/pull/10520</a>>`__: DOC: Proper .rst formatting for deprecated features and Backwards...<br>* `#10523 <<a href="https://github.com/scipy/scipy/pull/10523">https://github.com/scipy/scipy/pull/10523</a>>`__: DOC: Improve scipy.signal.resample documentation<br>* `#10524 <<a href="https://github.com/scipy/scipy/pull/10524">https://github.com/scipy/scipy/pull/10524</a>>`__: ENH: Add MGC to scipy.stats<br>* `#10525 <<a href="https://github.com/scipy/scipy/pull/10525">https://github.com/scipy/scipy/pull/10525</a>>`__: [ENH] ncx2.ppf dispatch to chi2 when nc=0<br>* `#10526 <<a href="https://github.com/scipy/scipy/pull/10526">https://github.com/scipy/scipy/pull/10526</a>>`__: DOC: clarify laplacian normalization<br>* `#10528 <<a href="https://github.com/scipy/scipy/pull/10528">https://github.com/scipy/scipy/pull/10528</a>>`__: API: Rename scipy.fft DCT/DST shape argument to s<br>* `#10531 <<a href="https://github.com/scipy/scipy/pull/10531">https://github.com/scipy/scipy/pull/10531</a>>`__: BUG: fixed improper rotations in spatial.transform.rotation.match_vectors<br>* `#10533 <<a href="https://github.com/scipy/scipy/pull/10533">https://github.com/scipy/scipy/pull/10533</a>>`__: [DOC] Add example for winsorize function<br>* `#10539 <<a href="https://github.com/scipy/scipy/pull/10539">https://github.com/scipy/scipy/pull/10539</a>>`__: MAINT: special: don't register \`i0\` with \`numpy.dual\`<br>* `#10540 <<a href="https://github.com/scipy/scipy/pull/10540">https://github.com/scipy/scipy/pull/10540</a>>`__: MAINT: Fix Travis and Circle<br>* `#10542 <<a href="https://github.com/scipy/scipy/pull/10542">https://github.com/scipy/scipy/pull/10542</a>>`__: MAINT: interpolate: use cython_lapack<br>* `#10547 <<a href="https://github.com/scipy/scipy/pull/10547">https://github.com/scipy/scipy/pull/10547</a>>`__: Feature request. Add furthest site Voronoi diagrams to scipy.spatial.plotutils.<br>* `#10549 <<a href="https://github.com/scipy/scipy/pull/10549">https://github.com/scipy/scipy/pull/10549</a>>`__: [BUG] Fix bug in trimr when inclusive=False<br>* `#10552 <<a href="https://github.com/scipy/scipy/pull/10552">https://github.com/scipy/scipy/pull/10552</a>>`__: add scipy.signal.upfirdn signal extension modes<br>* `#10555 <<a href="https://github.com/scipy/scipy/pull/10555">https://github.com/scipy/scipy/pull/10555</a>>`__: MAINT: special: move \`c_misc\` into Cephes<br>* `#10556 <<a href="https://github.com/scipy/scipy/pull/10556">https://github.com/scipy/scipy/pull/10556</a>>`__: [DOC] Add example for trima<br>* `#10562 <<a href="https://github.com/scipy/scipy/pull/10562">https://github.com/scipy/scipy/pull/10562</a>>`__: [DOC] Fix triple string fo trimmed so that __doc__ can show...<br>* `#10563 <<a href="https://github.com/scipy/scipy/pull/10563">https://github.com/scipy/scipy/pull/10563</a>>`__: improve least_squares error msg for mismatched shape<br>* `#10564 <<a href="https://github.com/scipy/scipy/pull/10564">https://github.com/scipy/scipy/pull/10564</a>>`__: ENH: linalg: memoize get_lapack/blas_funcs to speed it up<br>* `#10566 <<a href="https://github.com/scipy/scipy/pull/10566">https://github.com/scipy/scipy/pull/10566</a>>`__: ENH: add implementation of solver for the maximum flow problem<br>* `#10567 <<a href="https://github.com/scipy/scipy/pull/10567">https://github.com/scipy/scipy/pull/10567</a>>`__: BUG: spatial: use c++11 construct for getting start of vector...<br>* `#10568 <<a href="https://github.com/scipy/scipy/pull/10568">https://github.com/scipy/scipy/pull/10568</a>>`__: DOC: special: small tweaks to the \`zetac\` docstring<br>* `#10571 <<a href="https://github.com/scipy/scipy/pull/10571">https://github.com/scipy/scipy/pull/10571</a>>`__: [ENH] Gaussian_kde can accept matrix dataset<br>* `#10574 <<a href="https://github.com/scipy/scipy/pull/10574">https://github.com/scipy/scipy/pull/10574</a>>`__: ENH: linalg: speed up _compute_lwork by avoiding numpy constructs<br>* `#10582 <<a href="https://github.com/scipy/scipy/pull/10582">https://github.com/scipy/scipy/pull/10582</a>>`__: Fix typos with typos in bundled libraries reverted<br>* `#10583 <<a href="https://github.com/scipy/scipy/pull/10583">https://github.com/scipy/scipy/pull/10583</a>>`__: ENH: special: add the analytic continuation of Riemann zeta<br>* `#10584 <<a href="https://github.com/scipy/scipy/pull/10584">https://github.com/scipy/scipy/pull/10584</a>>`__: MAINT: special: clean up \`special.__all__\`<br>* `#10586 <<a href="https://github.com/scipy/scipy/pull/10586">https://github.com/scipy/scipy/pull/10586</a>>`__: BUG: multidimensional scipy.fft functions should accept 's' rather...<br>* `#10587 <<a href="https://github.com/scipy/scipy/pull/10587">https://github.com/scipy/scipy/pull/10587</a>>`__: BUG: integrate/lsoda: never abort run, set error istate instead<br>* `#10594 <<a href="https://github.com/scipy/scipy/pull/10594">https://github.com/scipy/scipy/pull/10594</a>>`__: API: Replicate numpy's fftn behaviour when s is given but not...<br>* `#10599 <<a href="https://github.com/scipy/scipy/pull/10599">https://github.com/scipy/scipy/pull/10599</a>>`__: DOC: dev: update documentation vs. github pull request workflow...<br>* `#10603 <<a href="https://github.com/scipy/scipy/pull/10603">https://github.com/scipy/scipy/pull/10603</a>>`__: MAINT: installer scripts removed<br>* `#10604 <<a href="https://github.com/scipy/scipy/pull/10604">https://github.com/scipy/scipy/pull/10604</a>>`__: MAINT: Change c\*np.ones(...) to np.full(..., c, ...) in many...<br>* `#10608 <<a href="https://github.com/scipy/scipy/pull/10608">https://github.com/scipy/scipy/pull/10608</a>>`__: Univariate splines should require x to be strictly increasing...<br>* `#10613 <<a href="https://github.com/scipy/scipy/pull/10613">https://github.com/scipy/scipy/pull/10613</a>>`__: ENH: Add seed option for gaussian_kde.resample<br>* `#10614 <<a href="https://github.com/scipy/scipy/pull/10614">https://github.com/scipy/scipy/pull/10614</a>>`__: ENH: Add parallel computation to scipy.fft<br>* `#10615 <<a href="https://github.com/scipy/scipy/pull/10615">https://github.com/scipy/scipy/pull/10615</a>>`__: MAINT: interpolate: remove unused header file<br>* `#10616 <<a href="https://github.com/scipy/scipy/pull/10616">https://github.com/scipy/scipy/pull/10616</a>>`__: MAINT: Clean up 32-bit platform xfail markers<br>* `#10618 <<a href="https://github.com/scipy/scipy/pull/10618">https://github.com/scipy/scipy/pull/10618</a>>`__: BENCH: Added 'trust-constr' to minimize benchmarks<br>* `#10621 <<a href="https://github.com/scipy/scipy/pull/10621">https://github.com/scipy/scipy/pull/10621</a>>`__: [MRG] multiple stability updates in lobpcg<br>* `#10622 <<a href="https://github.com/scipy/scipy/pull/10622">https://github.com/scipy/scipy/pull/10622</a>>`__: MAINT: forward port 1.3.1 release notes<br>* `#10624 <<a href="https://github.com/scipy/scipy/pull/10624">https://github.com/scipy/scipy/pull/10624</a>>`__: DOC: stats: Fix spelling of 'support'.<br>* `#10627 <<a href="https://github.com/scipy/scipy/pull/10627">https://github.com/scipy/scipy/pull/10627</a>>`__: DOC: stats: Add references for the alpha distribution.<br>* `#10629 <<a href="https://github.com/scipy/scipy/pull/10629">https://github.com/scipy/scipy/pull/10629</a>>`__: MAINT: special: avoid overflow longer in \`zeta\` for negative...<br>* `#10630 <<a href="https://github.com/scipy/scipy/pull/10630">https://github.com/scipy/scipy/pull/10630</a>>`__: TST: GH10271, relax test assertion, fixes #10271<br>* `#10631 <<a href="https://github.com/scipy/scipy/pull/10631">https://github.com/scipy/scipy/pull/10631</a>>`__: DOC: nelder-mean uses xatol fixes #10036<br>* `#10633 <<a href="https://github.com/scipy/scipy/pull/10633">https://github.com/scipy/scipy/pull/10633</a>>`__: BUG: interpolate: integral(a, b) should be zero when both limits...<br>* `#10635 <<a href="https://github.com/scipy/scipy/pull/10635">https://github.com/scipy/scipy/pull/10635</a>>`__: DOC: special: complete hypergeometric functions documentation<br>* `#10636 <<a href="https://github.com/scipy/scipy/pull/10636">https://github.com/scipy/scipy/pull/10636</a>>`__: BUG: special: use series for \`hyp1f1\` when it converges rapidly<br>* `#10641 <<a href="https://github.com/scipy/scipy/pull/10641">https://github.com/scipy/scipy/pull/10641</a>>`__: ENH: allow matching of general bipartite graphs<br>* `#10643 <<a href="https://github.com/scipy/scipy/pull/10643">https://github.com/scipy/scipy/pull/10643</a>>`__: ENH: scipy.sparse.linalg.spsolve triangular unit diagonal<br>* `#10650 <<a href="https://github.com/scipy/scipy/pull/10650">https://github.com/scipy/scipy/pull/10650</a>>`__: ENH: Cythonize sosfilt<br>* `#10654 <<a href="https://github.com/scipy/scipy/pull/10654">https://github.com/scipy/scipy/pull/10654</a>>`__: DOC: Vertical alignment of table entries<br>* `#10655 <<a href="https://github.com/scipy/scipy/pull/10655">https://github.com/scipy/scipy/pull/10655</a>>`__: ENH: Dockerfile for scipy development<br>* `#10660 <<a href="https://github.com/scipy/scipy/pull/10660">https://github.com/scipy/scipy/pull/10660</a>>`__: TST: clean up tests for rvs in scipy.stats<br>* `#10664 <<a href="https://github.com/scipy/scipy/pull/10664">https://github.com/scipy/scipy/pull/10664</a>>`__: Throw error on non-finite input for binned_statistic_dd()<br>* `#10665 <<a href="https://github.com/scipy/scipy/pull/10665">https://github.com/scipy/scipy/pull/10665</a>>`__: DOC: special: improve the docstrings for \`gamma\` and \`gammasgn\`<br>* `#10669 <<a href="https://github.com/scipy/scipy/pull/10669">https://github.com/scipy/scipy/pull/10669</a>>`__: TST: Update scipy.fft real transform tests<br>* `#10670 <<a href="https://github.com/scipy/scipy/pull/10670">https://github.com/scipy/scipy/pull/10670</a>>`__: DOC: Clarify docs and error messages for scipy.signal.butter<br>* `#10672 <<a href="https://github.com/scipy/scipy/pull/10672">https://github.com/scipy/scipy/pull/10672</a>>`__: ENH: return solution attribute when using events in solve_ivp<br>* `#10675 <<a href="https://github.com/scipy/scipy/pull/10675">https://github.com/scipy/scipy/pull/10675</a>>`__: MAINT: special: add an explicit NaN check for \`iv\` arguments<br>* `#10679 <<a href="https://github.com/scipy/scipy/pull/10679">https://github.com/scipy/scipy/pull/10679</a>>`__: DOC: special: Add documentation for \`beta\` function<br>* `#10681 <<a href="https://github.com/scipy/scipy/pull/10681">https://github.com/scipy/scipy/pull/10681</a>>`__: TST: sparse.linalg: fix arnoldi test seed<br>* `#10682 <<a href="https://github.com/scipy/scipy/pull/10682">https://github.com/scipy/scipy/pull/10682</a>>`__: DOC: special: Add documentation for \`betainc\` function<br>* `#10684 <<a href="https://github.com/scipy/scipy/pull/10684">https://github.com/scipy/scipy/pull/10684</a>>`__: TST: special: require Mpmath 1.1.0 for \`test_hyperu_around_0\`<br>* `#10686 <<a href="https://github.com/scipy/scipy/pull/10686">https://github.com/scipy/scipy/pull/10686</a>>`__: FIX: sphinx isattributedescriptor is not available in sphinx...<br>* `#10687 <<a href="https://github.com/scipy/scipy/pull/10687">https://github.com/scipy/scipy/pull/10687</a>>`__: DOC: added Docker quickstart guide by @andyfaff<br>* `#10689 <<a href="https://github.com/scipy/scipy/pull/10689">https://github.com/scipy/scipy/pull/10689</a>>`__: DOC: special: clarify format of parameters/returns sections for...<br>* `#10690 <<a href="https://github.com/scipy/scipy/pull/10690">https://github.com/scipy/scipy/pull/10690</a>>`__: DOC: special: improve docstrings of incomplete gamma functions<br>* `#10692 <<a href="https://github.com/scipy/scipy/pull/10692">https://github.com/scipy/scipy/pull/10692</a>>`__: ENH: higher-dimensional input in \`spatial.SphericalVoronoi\`<br>* `#10694 <<a href="https://github.com/scipy/scipy/pull/10694">https://github.com/scipy/scipy/pull/10694</a>>`__: ENH: ScalarFunction.fun_and_grad<br>* `#10698 <<a href="https://github.com/scipy/scipy/pull/10698">https://github.com/scipy/scipy/pull/10698</a>>`__: DOC: special: Add documentation for \`betaincinv\`<br>* `#10699 <<a href="https://github.com/scipy/scipy/pull/10699">https://github.com/scipy/scipy/pull/10699</a>>`__: MAINT: remove time print lbfgsb fixes #8417<br>* `#10701 <<a href="https://github.com/scipy/scipy/pull/10701">https://github.com/scipy/scipy/pull/10701</a>>`__: TST, MAINT: bump OpenBLAS to 0.3.7 stable<br>* `#10702 <<a href="https://github.com/scipy/scipy/pull/10702">https://github.com/scipy/scipy/pull/10702</a>>`__: DOC: clarify iterations consume multiple function calls<br>* `#10703 <<a href="https://github.com/scipy/scipy/pull/10703">https://github.com/scipy/scipy/pull/10703</a>>`__: DOC: iprint doc lbfgsb closes #5482<br>* `#10708 <<a href="https://github.com/scipy/scipy/pull/10708">https://github.com/scipy/scipy/pull/10708</a>>`__: TST: test suggested in gh1758<br>* `#10710 <<a href="https://github.com/scipy/scipy/pull/10710">https://github.com/scipy/scipy/pull/10710</a>>`__: ENH: Added nan_policy to circ functions in \`stats\`<br>* `#10712 <<a href="https://github.com/scipy/scipy/pull/10712">https://github.com/scipy/scipy/pull/10712</a>>`__: ENH: add axis parameter to stats.entropy<br>* `#10714 <<a href="https://github.com/scipy/scipy/pull/10714">https://github.com/scipy/scipy/pull/10714</a>>`__: DOC: Formatting fix rv_continuous.expect docs<br>* `#10715 <<a href="https://github.com/scipy/scipy/pull/10715">https://github.com/scipy/scipy/pull/10715</a>>`__: DOC: BLD: update doc Makefile for python version; add scipy version...<br>* `#10717 <<a href="https://github.com/scipy/scipy/pull/10717">https://github.com/scipy/scipy/pull/10717</a>>`__: MAINT: modernize doc/Makefile<br>* `#10719 <<a href="https://github.com/scipy/scipy/pull/10719">https://github.com/scipy/scipy/pull/10719</a>>`__: Enable setting minres initial vector<br>* `#10720 <<a href="https://github.com/scipy/scipy/pull/10720">https://github.com/scipy/scipy/pull/10720</a>>`__: DOC: silence random warning in doc build for \`stats.binned_statistic_dd\`<br>* `#10724 <<a href="https://github.com/scipy/scipy/pull/10724">https://github.com/scipy/scipy/pull/10724</a>>`__: DEV: Add doc option to runtests.py<br>* `#10728 <<a href="https://github.com/scipy/scipy/pull/10728">https://github.com/scipy/scipy/pull/10728</a>>`__: MAINT: get rid of gramA, gramB text files that lobpcg tests leave...<br>* `#10732 <<a href="https://github.com/scipy/scipy/pull/10732">https://github.com/scipy/scipy/pull/10732</a>>`__: DOC: add min_only to docstring for Dijkstra's algorithm<br>* `#10734 <<a href="https://github.com/scipy/scipy/pull/10734">https://github.com/scipy/scipy/pull/10734</a>>`__: DOC: spell out difference between source and target in shortest...<br>* `#10735 <<a href="https://github.com/scipy/scipy/pull/10735">https://github.com/scipy/scipy/pull/10735</a>>`__: Fix for Python 4<br>* `#10739 <<a href="https://github.com/scipy/scipy/pull/10739">https://github.com/scipy/scipy/pull/10739</a>>`__: BUG: optimize/slsqp: deal with singular BFGS update<br>* `#10741 <<a href="https://github.com/scipy/scipy/pull/10741">https://github.com/scipy/scipy/pull/10741</a>>`__: ENH: LAPACK wrappers for ?geequ, ?geequb, ?syequb, ?heequb<br>* `#10742 <<a href="https://github.com/scipy/scipy/pull/10742">https://github.com/scipy/scipy/pull/10742</a>>`__: DOC: special: add to the docstring of \`gammaln\`<br>* `#10743 <<a href="https://github.com/scipy/scipy/pull/10743">https://github.com/scipy/scipy/pull/10743</a>>`__: ENH: special: add a real dispatch for \`wrightomega\`<br>* `#10746 <<a href="https://github.com/scipy/scipy/pull/10746">https://github.com/scipy/scipy/pull/10746</a>>`__: MAINT: Fix typos in comments, docs and test name<br>* `#10747 <<a href="https://github.com/scipy/scipy/pull/10747">https://github.com/scipy/scipy/pull/10747</a>>`__: Remove spurious quotes<br>* `#10750 <<a href="https://github.com/scipy/scipy/pull/10750">https://github.com/scipy/scipy/pull/10750</a>>`__: MAINT: make cython code more precise<br>* `#10751 <<a href="https://github.com/scipy/scipy/pull/10751">https://github.com/scipy/scipy/pull/10751</a>>`__: MAINT: Check that scipy.linalg.lapack functions are documented<br>* `#10752 <<a href="https://github.com/scipy/scipy/pull/10752">https://github.com/scipy/scipy/pull/10752</a>>`__: MAINT: special: use \`sf_error\` in Cephes<br>* `#10755 <<a href="https://github.com/scipy/scipy/pull/10755">https://github.com/scipy/scipy/pull/10755</a>>`__: DOC: cluster: Add 'See Also' and 'Examples' for kmeans2.<br>* `#10763 <<a href="https://github.com/scipy/scipy/pull/10763">https://github.com/scipy/scipy/pull/10763</a>>`__: MAINT: list of minimize methods<br>* `#10768 <<a href="https://github.com/scipy/scipy/pull/10768">https://github.com/scipy/scipy/pull/10768</a>>`__: BUG: Fix corner case for sos2zpk<br>* `#10773 <<a href="https://github.com/scipy/scipy/pull/10773">https://github.com/scipy/scipy/pull/10773</a>>`__: Fix error type for complex input to scipy.fftpack.rfft and irfft<br>* `#10776 <<a href="https://github.com/scipy/scipy/pull/10776">https://github.com/scipy/scipy/pull/10776</a>>`__: ENH: handle geodesic input in \`spatial.SphericalVoronoi\`<br>* `#10777 <<a href="https://github.com/scipy/scipy/pull/10777">https://github.com/scipy/scipy/pull/10777</a>>`__: MAINT: minimizer-->custom should handle the kinds of bounds/constrain…...<br>* `#10781 <<a href="https://github.com/scipy/scipy/pull/10781">https://github.com/scipy/scipy/pull/10781</a>>`__: ENH: solve_triangular C order improvement<br>* `#10787 <<a href="https://github.com/scipy/scipy/pull/10787">https://github.com/scipy/scipy/pull/10787</a>>`__: Fix behavior of \`exp1\` on branch cut and add docstring<br>* `#10789 <<a href="https://github.com/scipy/scipy/pull/10789">https://github.com/scipy/scipy/pull/10789</a>>`__: DOC: special: add parameters/returns doc sections for erfc/erfcx/erfi<br>* `#10790 <<a href="https://github.com/scipy/scipy/pull/10790">https://github.com/scipy/scipy/pull/10790</a>>`__: Travis CI: sudo is deprecated and Xenial is default distro<br>* `#10792 <<a href="https://github.com/scipy/scipy/pull/10792">https://github.com/scipy/scipy/pull/10792</a>>`__: DOC: special: add full docstring for \`expi\`<br>* `#10799 <<a href="https://github.com/scipy/scipy/pull/10799">https://github.com/scipy/scipy/pull/10799</a>>`__: DOC: special: add a complete docstring for \`expn\`<br>* `#10800 <<a href="https://github.com/scipy/scipy/pull/10800">https://github.com/scipy/scipy/pull/10800</a>>`__: Docs edits (GSoD)<br>* `#10802 <<a href="https://github.com/scipy/scipy/pull/10802">https://github.com/scipy/scipy/pull/10802</a>>`__: BUG: fix UnboundLocalError in Radau (scipy#10775)<br>* `#10804 <<a href="https://github.com/scipy/scipy/pull/10804">https://github.com/scipy/scipy/pull/10804</a>>`__: ENH: Speed up next_fast_len with LRU cache<br>* `#10805 <<a href="https://github.com/scipy/scipy/pull/10805">https://github.com/scipy/scipy/pull/10805</a>>`__: DOC: Fix unbalanced quotes in signal.place_poles<br>* `#10809 <<a href="https://github.com/scipy/scipy/pull/10809">https://github.com/scipy/scipy/pull/10809</a>>`__: ENH: Speed up next_fast_len<br>* `#10810 <<a href="https://github.com/scipy/scipy/pull/10810">https://github.com/scipy/scipy/pull/10810</a>>`__: ENH: Raise catchable exceptions for bad Fortran files<br>* `#10811 <<a href="https://github.com/scipy/scipy/pull/10811">https://github.com/scipy/scipy/pull/10811</a>>`__: MAINT: optimize: Remove extra variable from _remove_redundancy_dense<br>* `#10813 <<a href="https://github.com/scipy/scipy/pull/10813">https://github.com/scipy/scipy/pull/10813</a>>`__: MAINT: special: Remove unused variables from _kolmogi and _smirnovi<br>* `#10815 <<a href="https://github.com/scipy/scipy/pull/10815">https://github.com/scipy/scipy/pull/10815</a>>`__: DOC, API: scipy.stats.reciprocal is "log-uniform"<br>* `#10816 <<a href="https://github.com/scipy/scipy/pull/10816">https://github.com/scipy/scipy/pull/10816</a>>`__: MAINT: special: remove deprecated \`bessel_diff_formula\`<br>* `#10817 <<a href="https://github.com/scipy/scipy/pull/10817">https://github.com/scipy/scipy/pull/10817</a>>`__: DOC: special: complete the docstring for \`fresnel\`<br>* `#10820 <<a href="https://github.com/scipy/scipy/pull/10820">https://github.com/scipy/scipy/pull/10820</a>>`__: Fixed compiler_helper.py to allow compilation with ICC on Linux<br>* `#10823 <<a href="https://github.com/scipy/scipy/pull/10823">https://github.com/scipy/scipy/pull/10823</a>>`__: DOC: updated reference guide text for consistency in writing...<br>* `#10825 <<a href="https://github.com/scipy/scipy/pull/10825">https://github.com/scipy/scipy/pull/10825</a>>`__: MAINT: special: change some features of the Voigt function<br>* `#10828 <<a href="https://github.com/scipy/scipy/pull/10828">https://github.com/scipy/scipy/pull/10828</a>>`__: MAINT: integrate: Remove unused variable from init_callback<br>* `#10830 <<a href="https://github.com/scipy/scipy/pull/10830">https://github.com/scipy/scipy/pull/10830</a>>`__: Adding LOBPCG solver in svds in addition to ARPACK<br>* `#10837 <<a href="https://github.com/scipy/scipy/pull/10837">https://github.com/scipy/scipy/pull/10837</a>>`__: WIP: ENH: reduction function for \`spatial.tranform.Rotation\`...<br>* `#10843 <<a href="https://github.com/scipy/scipy/pull/10843">https://github.com/scipy/scipy/pull/10843</a>>`__: ENH: Adding optional parameter to stats.zscores to allow for...<br>* `#10845 <<a href="https://github.com/scipy/scipy/pull/10845">https://github.com/scipy/scipy/pull/10845</a>>`__: Rebase kruskal fix<br>* `#10847 <<a href="https://github.com/scipy/scipy/pull/10847">https://github.com/scipy/scipy/pull/10847</a>>`__: remove redundant __getitem__ from scipy.sparse.lil<br>* `#10848 <<a href="https://github.com/scipy/scipy/pull/10848">https://github.com/scipy/scipy/pull/10848</a>>`__: Better handling of empty (not missing) docstrings<br>* `#10849 <<a href="https://github.com/scipy/scipy/pull/10849">https://github.com/scipy/scipy/pull/10849</a>>`__: ENH: implement rmatmat for LinearOperator<br>* `#10850 <<a href="https://github.com/scipy/scipy/pull/10850">https://github.com/scipy/scipy/pull/10850</a>>`__: MAINT : Refactoring lil List of Lists<br>* `#10851 <<a href="https://github.com/scipy/scipy/pull/10851">https://github.com/scipy/scipy/pull/10851</a>>`__: DOC: add a generative art example to the scipy.spatial tutorial.<br>* `#10852 <<a href="https://github.com/scipy/scipy/pull/10852">https://github.com/scipy/scipy/pull/10852</a>>`__: DOC: linalg: fixed gh-10838 unused imports in example deleted<br>* `#10854 <<a href="https://github.com/scipy/scipy/pull/10854">https://github.com/scipy/scipy/pull/10854</a>>`__: DOC: special: add a full docstring for \`pdtr\`<br>* `#10861 <<a href="https://github.com/scipy/scipy/pull/10861">https://github.com/scipy/scipy/pull/10861</a>>`__: ENH: option to reuse binnumbers in stats.binned_statistic_dd<br>* `#10863 <<a href="https://github.com/scipy/scipy/pull/10863">https://github.com/scipy/scipy/pull/10863</a>>`__: DOC: partial standardization and validation of scipy.stats reference...<br>* `#10865 <<a href="https://github.com/scipy/scipy/pull/10865">https://github.com/scipy/scipy/pull/10865</a>>`__: BUG: special: fix incomplete gamma functions for infinite \`a\`<br>* `#10866 <<a href="https://github.com/scipy/scipy/pull/10866">https://github.com/scipy/scipy/pull/10866</a>>`__: ENH: calculation of mean in spatial.transform.Rotation<br>* `#10867 <<a href="https://github.com/scipy/scipy/pull/10867">https://github.com/scipy/scipy/pull/10867</a>>`__: MAINT: Also store latex directory<br>* `#10869 <<a href="https://github.com/scipy/scipy/pull/10869">https://github.com/scipy/scipy/pull/10869</a>>`__: ENH: Implement overlap-add convolution<br>* `#10870 <<a href="https://github.com/scipy/scipy/pull/10870">https://github.com/scipy/scipy/pull/10870</a>>`__: ENH: Do not raise EOF error if wavfile data read<br>* `#10876 <<a href="https://github.com/scipy/scipy/pull/10876">https://github.com/scipy/scipy/pull/10876</a>>`__: ENH: Add beta-binomial distribution to scipy.stats<br>* `#10878 <<a href="https://github.com/scipy/scipy/pull/10878">https://github.com/scipy/scipy/pull/10878</a>>`__: MAINT: Update R project URL<br>* `#10883 <<a href="https://github.com/scipy/scipy/pull/10883">https://github.com/scipy/scipy/pull/10883</a>>`__: MAINT: (ndimage) More robust check for output being a numpy dtype<br>* `#10884 <<a href="https://github.com/scipy/scipy/pull/10884">https://github.com/scipy/scipy/pull/10884</a>>`__: DOC: Added instructions on adding a new distribution to scipy.stats.<br>* `#10885 <<a href="https://github.com/scipy/scipy/pull/10885">https://github.com/scipy/scipy/pull/10885</a>>`__: [BUG] fix lobpcg with maxiter=None results in Exception<br>* `#10899 <<a href="https://github.com/scipy/scipy/pull/10899">https://github.com/scipy/scipy/pull/10899</a>>`__: ENH: Match R functionality for hmean<br>* `#10900 <<a href="https://github.com/scipy/scipy/pull/10900">https://github.com/scipy/scipy/pull/10900</a>>`__: MAINT: stats: Use keepdims to simplify a few lines in power_divergence.<br>* `#10901 <<a href="https://github.com/scipy/scipy/pull/10901">https://github.com/scipy/scipy/pull/10901</a>>`__: ENH: sparse/linalg: support pydata/sparse matrices<br>* `#10907 <<a href="https://github.com/scipy/scipy/pull/10907">https://github.com/scipy/scipy/pull/10907</a>>`__: Check whether \`maxiter\` is integer<br>* `#10912 <<a href="https://github.com/scipy/scipy/pull/10912">https://github.com/scipy/scipy/pull/10912</a>>`__: ENH: warn user that quad() ignores \`points=...\` when \`weight=...\`...<br>* `#10918 <<a href="https://github.com/scipy/scipy/pull/10918">https://github.com/scipy/scipy/pull/10918</a>>`__: CI: fix Travis CI py3.8 build<br>* `#10920 <<a href="https://github.com/scipy/scipy/pull/10920">https://github.com/scipy/scipy/pull/10920</a>>`__: MAINT: Update constants to codata 2018 values (second try)<br>* `#10921 <<a href="https://github.com/scipy/scipy/pull/10921">https://github.com/scipy/scipy/pull/10921</a>>`__: ENH: scipy.sparse.lil: tocsr accelerated<br>* `#10924 <<a href="https://github.com/scipy/scipy/pull/10924">https://github.com/scipy/scipy/pull/10924</a>>`__: BUG: Forbid passing 'args' as kwarg in scipy.optimize.curve_fit<br>* `#10928 <<a href="https://github.com/scipy/scipy/pull/10928">https://github.com/scipy/scipy/pull/10928</a>>`__: DOC: Add examples to io.wavfile docstrings<br>* `#10934 <<a href="https://github.com/scipy/scipy/pull/10934">https://github.com/scipy/scipy/pull/10934</a>>`__: typo fix<br>* `#10935 <<a href="https://github.com/scipy/scipy/pull/10935">https://github.com/scipy/scipy/pull/10935</a>>`__: BUG: Avoid undefined behaviour on float to unsigned conversion<br>* `#10936 <<a href="https://github.com/scipy/scipy/pull/10936">https://github.com/scipy/scipy/pull/10936</a>>`__: DOC: Added missing example to stats.mstats.variation<br>* `#10939 <<a href="https://github.com/scipy/scipy/pull/10939">https://github.com/scipy/scipy/pull/10939</a>>`__: ENH: scipy.sparse.lil: tocsr accelerated depending on density<br>* `#10946 <<a href="https://github.com/scipy/scipy/pull/10946">https://github.com/scipy/scipy/pull/10946</a>>`__: BUG: setting verbose > 2 in minimize with trust-constr method...<br>* `#10947 <<a href="https://github.com/scipy/scipy/pull/10947">https://github.com/scipy/scipy/pull/10947</a>>`__: DOC: special: small improvements to the \`poch\` docstring<br>* `#10949 <<a href="https://github.com/scipy/scipy/pull/10949">https://github.com/scipy/scipy/pull/10949</a>>`__: BUG: fix return type of erlang_gen._argcheck<br>* `#10951 <<a href="https://github.com/scipy/scipy/pull/10951">https://github.com/scipy/scipy/pull/10951</a>>`__: DOC: fixed Ricker wavelet formula<br>* `#10954 <<a href="https://github.com/scipy/scipy/pull/10954">https://github.com/scipy/scipy/pull/10954</a>>`__: BUG: special: fix \`factorial\` return type for 0-d inputs<br>* `#10955 <<a href="https://github.com/scipy/scipy/pull/10955">https://github.com/scipy/scipy/pull/10955</a>>`__: MAINT: Relax the assert_unitary atol value<br>* `#10956 <<a href="https://github.com/scipy/scipy/pull/10956">https://github.com/scipy/scipy/pull/10956</a>>`__: WIP: make pdtr(int, double) be pdtr(double, double)<br>* `#10957 <<a href="https://github.com/scipy/scipy/pull/10957">https://github.com/scipy/scipy/pull/10957</a>>`__: BUG: Ensure full binary compatibility of long double test data<br>* `#10964 <<a href="https://github.com/scipy/scipy/pull/10964">https://github.com/scipy/scipy/pull/10964</a>>`__: ENH: Make Slerp callable with a scalar argument<br>* `#10972 <<a href="https://github.com/scipy/scipy/pull/10972">https://github.com/scipy/scipy/pull/10972</a>>`__: BUG: Handle complex gains in zpk2sos<br>* `#10975 <<a href="https://github.com/scipy/scipy/pull/10975">https://github.com/scipy/scipy/pull/10975</a>>`__: TST: skip test_kendalltau ppc64le<br>* `#10978 <<a href="https://github.com/scipy/scipy/pull/10978">https://github.com/scipy/scipy/pull/10978</a>>`__: BUG: boxcox data dimension and constancy check #5112<br>* `#10979 <<a href="https://github.com/scipy/scipy/pull/10979">https://github.com/scipy/scipy/pull/10979</a>>`__: API: Rename dcm to (rotation) matrix in Rotation class<br>* `#10981 <<a href="https://github.com/scipy/scipy/pull/10981">https://github.com/scipy/scipy/pull/10981</a>>`__: MAINT: add support for a==0 and x>0 edge case to igam and igamc<br>* `#10986 <<a href="https://github.com/scipy/scipy/pull/10986">https://github.com/scipy/scipy/pull/10986</a>>`__: MAINT: Remove direct imports from numpy in signaltools.py<br>* `#10988 <<a href="https://github.com/scipy/scipy/pull/10988">https://github.com/scipy/scipy/pull/10988</a>>`__: BUG: signal: fixed issue #10360<br>* `#10989 <<a href="https://github.com/scipy/scipy/pull/10989">https://github.com/scipy/scipy/pull/10989</a>>`__: FIX binned_statistic_dd Mac wheel test fails<br>* `#10990 <<a href="https://github.com/scipy/scipy/pull/10990">https://github.com/scipy/scipy/pull/10990</a>>`__: BUG: Fix memory leak in shgo triangulation<br>* `#10992 <<a href="https://github.com/scipy/scipy/pull/10992">https://github.com/scipy/scipy/pull/10992</a>>`__: TST: Relax tolerance in upfirdn test_modes<br>* `#10993 <<a href="https://github.com/scipy/scipy/pull/10993">https://github.com/scipy/scipy/pull/10993</a>>`__: TST: bump tolerance in optimize tests<br>* `#10997 <<a href="https://github.com/scipy/scipy/pull/10997">https://github.com/scipy/scipy/pull/10997</a>>`__: MAINT: Rework residue and residuez<br>* `#11001 <<a href="https://github.com/scipy/scipy/pull/11001">https://github.com/scipy/scipy/pull/11001</a>>`__: DOC: Updated Windows build tutorial<br>* `#11004 <<a href="https://github.com/scipy/scipy/pull/11004">https://github.com/scipy/scipy/pull/11004</a>>`__: BUG: integrate/quad_vec: fix several bugs in quad_vec<br>* `#11005 <<a href="https://github.com/scipy/scipy/pull/11005">https://github.com/scipy/scipy/pull/11005</a>>`__: TST: add Python 3.8 Win CI<br>* `#11006 <<a href="https://github.com/scipy/scipy/pull/11006">https://github.com/scipy/scipy/pull/11006</a>>`__: DOC: special: add a reference for \`kl_div\`<br>* `#11012 <<a href="https://github.com/scipy/scipy/pull/11012">https://github.com/scipy/scipy/pull/11012</a>>`__: MAINT: Rework invres and invresz<br>* `#11015 <<a href="https://github.com/scipy/scipy/pull/11015">https://github.com/scipy/scipy/pull/11015</a>>`__: DOC: special: add references for \`rel_entr\`<br>* `#11017 <<a href="https://github.com/scipy/scipy/pull/11017">https://github.com/scipy/scipy/pull/11017</a>>`__: DOC: numpydoc validation of morestats.py<br>* `#11018 <<a href="https://github.com/scipy/scipy/pull/11018">https://github.com/scipy/scipy/pull/11018</a>>`__: MAINT: Filter unrelated warning<br>* `#11031 <<a href="https://github.com/scipy/scipy/pull/11031">https://github.com/scipy/scipy/pull/11031</a>>`__: MAINT: update choose_conv_method for pocketfft implementation<br>* `#11034 <<a href="https://github.com/scipy/scipy/pull/11034">https://github.com/scipy/scipy/pull/11034</a>>`__: MAINT: TST: Skip tests with multiprocessing that use "spawn"...<br>* `#11036 <<a href="https://github.com/scipy/scipy/pull/11036">https://github.com/scipy/scipy/pull/11036</a>>`__: DOC: update doc/README with some more useful content.<br>* `#11037 <<a href="https://github.com/scipy/scipy/pull/11037">https://github.com/scipy/scipy/pull/11037</a>>`__: DOC: special: add a complete docstring for \`rgamma\`<br>* `#11038 <<a href="https://github.com/scipy/scipy/pull/11038">https://github.com/scipy/scipy/pull/11038</a>>`__: DOC: special: add a reference for the polygamma function<br>* `#11042 <<a href="https://github.com/scipy/scipy/pull/11042">https://github.com/scipy/scipy/pull/11042</a>>`__: TST: fix tf2zpk test failure due to incorrect complex sorting.<br>* `#11044 <<a href="https://github.com/scipy/scipy/pull/11044">https://github.com/scipy/scipy/pull/11044</a>>`__: MAINT: choose_conv_method can choose fftconvolution for longcomplex<br>* `#11046 <<a href="https://github.com/scipy/scipy/pull/11046">https://github.com/scipy/scipy/pull/11046</a>>`__: TST: Reduce tolerance for ppc64le with reference lapack<br>* `#11048 <<a href="https://github.com/scipy/scipy/pull/11048">https://github.com/scipy/scipy/pull/11048</a>>`__: DOC: special: add reference for orthogonal polynomial functions<br>* `#11049 <<a href="https://github.com/scipy/scipy/pull/11049">https://github.com/scipy/scipy/pull/11049</a>>`__: MAINT: proper random number initialization and readability fix<br>* `#11051 <<a href="https://github.com/scipy/scipy/pull/11051">https://github.com/scipy/scipy/pull/11051</a>>`__: MAINT: pep8 cleanup<br>* `#11054 <<a href="https://github.com/scipy/scipy/pull/11054">https://github.com/scipy/scipy/pull/11054</a>>`__: TST: bump test precision for dual_annealing SLSQP test<br>* `#11055 <<a href="https://github.com/scipy/scipy/pull/11055">https://github.com/scipy/scipy/pull/11055</a>>`__: DOC: special: add a reference for \`zeta\`<br>* `#11056 <<a href="https://github.com/scipy/scipy/pull/11056">https://github.com/scipy/scipy/pull/11056</a>>`__: API: Deprecated normalized keyword in Rotation<br>* `#11065 <<a href="https://github.com/scipy/scipy/pull/11065">https://github.com/scipy/scipy/pull/11065</a>>`__: DOC: Ubuntu Development Environment Quickstart should not modify...<br>* `#11066 <<a href="https://github.com/scipy/scipy/pull/11066">https://github.com/scipy/scipy/pull/11066</a>>`__: BUG: skip deprecation for numpy top-level types<br>* `#11067 <<a href="https://github.com/scipy/scipy/pull/11067">https://github.com/scipy/scipy/pull/11067</a>>`__: DOC: updated documentation for consistency in writing style<br>* `#11070 <<a href="https://github.com/scipy/scipy/pull/11070">https://github.com/scipy/scipy/pull/11070</a>>`__: DOC: Amendment to Ubuntu Development Environment Quickstart should...<br>* `#11073 <<a href="https://github.com/scipy/scipy/pull/11073">https://github.com/scipy/scipy/pull/11073</a>>`__: DOC: fix 1.4.0 release notes<br>* `#11081 <<a href="https://github.com/scipy/scipy/pull/11081">https://github.com/scipy/scipy/pull/11081</a>>`__: API: Replace Rotation.match_vectors with align_vectors<br>* `#11083 <<a href="https://github.com/scipy/scipy/pull/11083">https://github.com/scipy/scipy/pull/11083</a>>`__: DOC: more 1.4.0 release note fixes<br>* `#11092 <<a href="https://github.com/scipy/scipy/pull/11092">https://github.com/scipy/scipy/pull/11092</a>>`__: BUG: stats: fix freezing of some distributions<br>* `#11096 <<a href="https://github.com/scipy/scipy/pull/11096">https://github.com/scipy/scipy/pull/11096</a>>`__: BUG: scipy.sparse.csgraph: fixed issue #10774<br>* `#11124 <<a href="https://github.com/scipy/scipy/pull/11124">https://github.com/scipy/scipy/pull/11124</a>>`__: fix Cython warnings related to _stats.pyx<br>* `#11126 <<a href="https://github.com/scipy/scipy/pull/11126">https://github.com/scipy/scipy/pull/11126</a>>`__: BUG: interpolate/fitpack: fix memory leak in splprep<br>* `#11127 <<a href="https://github.com/scipy/scipy/pull/11127">https://github.com/scipy/scipy/pull/11127</a>>`__: Avoid potential segfault in CSR and CSC matrix indexing<br>* `#11152 <<a href="https://github.com/scipy/scipy/pull/11152">https://github.com/scipy/scipy/pull/11152</a>>`__: BUG: Fix random state bug multiscale_graphcorr<br>* `#11166 <<a href="https://github.com/scipy/scipy/pull/11166">https://github.com/scipy/scipy/pull/11166</a>>`__: BUG: empty sparse slice shapes<br>* `#11167 <<a href="https://github.com/scipy/scipy/pull/11167">https://github.com/scipy/scipy/pull/11167</a>>`__: BUG: redundant fft in signal.resample<br><br>Checksums<br>=========<br><br>MD5<br>~~~<br><br>3ab6ebe868c3b16a748ba483d4f6cec3  scipy-1.4.0rc2-cp35-cp35m-macosx_10_6_intel.whl<br>bc542c69def16b92b3900c851e7491b0  scipy-1.4.0rc2-cp35-cp35m-manylinux1_i686.whl<br>1fadb397d1f58a08b0da231259c10816  scipy-1.4.0rc2-cp35-cp35m-manylinux1_x86_64.whl<br>29d3aa36c52729ae67ca7b6980f9b44e  scipy-1.4.0rc2-cp35-cp35m-win32.whl<br>ffffa242b51400c2f536180fa9443c4f  scipy-1.4.0rc2-cp35-cp35m-win_amd64.whl<br>3d466f067cff2a3f71d16c6022e3354e  scipy-1.4.0rc2-cp36-cp36m-macosx_10_6_intel.whl<br>52bc6d2c58d020bf87afef25ea08f299  scipy-1.4.0rc2-cp36-cp36m-manylinux1_i686.whl<br>7f113e16db14cd1a76a24efe8ae33ae6  scipy-1.4.0rc2-cp36-cp36m-manylinux1_x86_64.whl<br>6bfba597a057e2c88d92a1db61846016  scipy-1.4.0rc2-cp36-cp36m-win32.whl<br>674a0520f3978757ce77df359dc954b7  scipy-1.4.0rc2-cp36-cp36m-win_amd64.whl<br>3a22aa80a6935cfaf5812f9a49139ef9  scipy-1.4.0rc2-cp37-cp37m-macosx_10_6_intel.whl<br>fe97f8eb1dd0e9742666a50d86c0f1a0  scipy-1.4.0rc2-cp37-cp37m-manylinux1_i686.whl<br>febdb9c5b10427f5dcf443c156b6cd91  scipy-1.4.0rc2-cp37-cp37m-manylinux1_x86_64.whl<br>fc2d9014976b2e242edc0dc80b2ba66e  scipy-1.4.0rc2-cp37-cp37m-win32.whl<br>65ca602dfee2cc3caf02f2c5e5c8e1d4  scipy-1.4.0rc2-cp37-cp37m-win_amd64.whl<br>d43b47ecc3f73047a42bee9252a8efad  scipy-1.4.0rc2-cp38-cp38-macosx_10_9_x86_64.whl<br>ddf4f0dc24cfa6e13ac858ce0fdf4d09  scipy-1.4.0rc2-cp38-cp38-manylinux1_i686.whl<br>8134c53abb2c3314300028c6fd49f9b4  scipy-1.4.0rc2-cp38-cp38-manylinux1_x86_64.whl<br>4142a48802a646f1c9233a4361b6f9ce  scipy-1.4.0rc2-cp38-cp38-win32.whl<br>f9398792343b4d19b7835b5fab52f741  scipy-1.4.0rc2-cp38-cp38-win_amd64.whl<br>cca43623b5d48dff880c5e5cea018fe3  scipy-1.4.0rc2.tar.gz<br>12e517b38e8cd226f9d1b3c8dbdf3fcb  scipy-1.4.0rc2.tar.xz<br>b14653ad2919de51f8436a016f10895e  scipy-1.4.0rc2.zip<br><br>SHA256<br>~~~~~~<br><br>1b2a564ea79da573cf9a481c71e70a7d6898ec59ab802b7fc46ce886baa4dbbf  scipy-1.4.0rc2-cp35-cp35m-macosx_10_6_intel.whl<br>37a2faa3aa6d9783e07aa52409bed0ba8bfc6e3e750ae7987bc038f1ee6854a6  scipy-1.4.0rc2-cp35-cp35m-manylinux1_i686.whl<br>86ac119d107371194a9158b4d940a325de1d6f997acc70497b691f58e227e3c8  scipy-1.4.0rc2-cp35-cp35m-manylinux1_x86_64.whl<br>dc86610b8386e1a2f927271d0815eed2d27a498ee79a9729c50372f87e1eca2a  scipy-1.4.0rc2-cp35-cp35m-win32.whl<br>00e54b1097e4dc91347977874cfabd4bcc8285b2c3fee176e538588c0f84035c  scipy-1.4.0rc2-cp35-cp35m-win_amd64.whl<br>7f84cd16a13423e5caf1d1c6265d4075313eff421251da7dbc9116c102f962c3  scipy-1.4.0rc2-cp36-cp36m-macosx_10_6_intel.whl<br>d07ea1bbe4e77835c266ea0e9108e6e3dc31327b734c003c203c6164f9c116cb  scipy-1.4.0rc2-cp36-cp36m-manylinux1_i686.whl<br>331d2bac603479ad845e6df136b1fab8c086eaef9da73c84cf22cd59ac9b2a14  scipy-1.4.0rc2-cp36-cp36m-manylinux1_x86_64.whl<br>885f60ad9166acead66afb40d36b6c7f5bcc6ad495333e8a1eb5f2afdb4da098  scipy-1.4.0rc2-cp36-cp36m-win32.whl<br>6dc2634ddc7968b55665b65f1e4fa970a7acdc44b0b8ec710c616d03018fe80b  scipy-1.4.0rc2-cp36-cp36m-win_amd64.whl<br>04e10d4a758ddc6b83fa62469510b807901883760306d86db37921180d8366b7  scipy-1.4.0rc2-cp37-cp37m-macosx_10_6_intel.whl<br>e29cf828929f1aadba8fb93a5dccc03703da139e5366fb57dc69f14417258bcd  scipy-1.4.0rc2-cp37-cp37m-manylinux1_i686.whl<br>d45319e0c2218f50bce99b3c887fe6394f6a823786fd5b343de29be122efc253  scipy-1.4.0rc2-cp37-cp37m-manylinux1_x86_64.whl<br>bd05f8a0c7e773a7e6102cbf6984f54e74f2f41af95cb007e81e7a313347a639  scipy-1.4.0rc2-cp37-cp37m-win32.whl<br>fceb14784f3bc7471f9fb43474956fdf7e2d14357a07fba9ba90b7a7aa91e5f2  scipy-1.4.0rc2-cp37-cp37m-win_amd64.whl<br>2eb614a45a4bc35c1fd01602743b73c4b0798e46080f7099b8c247cabedba3bf  scipy-1.4.0rc2-cp38-cp38-macosx_10_9_x86_64.whl<br>acd81d06cc3c8ab3a0e514db3b844abccfbf455f77dc79b969431fd61f2b29ce  scipy-1.4.0rc2-cp38-cp38-manylinux1_i686.whl<br>433a549ad92d4ba96b3c11ca3b6a43346a50303f7b9423acd92d9fb2d43b9534  scipy-1.4.0rc2-cp38-cp38-manylinux1_x86_64.whl<br>db023118e60ed5a5b41e8851bb294d24196f01677a66f8b41b917f7e9fca3f6f  scipy-1.4.0rc2-cp38-cp38-win32.whl<br>19ab29d38c3e574d631fc42487a1edc19c7f970269389a4debf7d8b12d808e20  scipy-1.4.0rc2-cp38-cp38-win_amd64.whl<br>08da7047f17e38d45e09bda565512a62808b1c896edb54abbcd2e39dfa0588f4  scipy-1.4.0rc2.tar.gz<br>c8d413030607d665d589f5933e88035a4518590e705a622e477621782b842a5c  scipy-1.4.0rc2.tar.xz<br>178d744fefadbc3d32b6362708c1ebc501fbe8d40015a6dbac40f095234a8354  scipy-1.4.0rc2.zip<br>-----BEGIN PGP SIGNATURE-----<br>Version: GnuPG v2<br><br>iQIcBAEBCAAGBQJd7VJHAAoJELD/41ZX0J71TN0P/2r2axB83q7MXoXGbjlENVXX<br>hG4olBusdspYYA5tGvgQzQAFEztpHRyQyssOTOnPsOVSQfOf/cGkhe5keRNx9jeg<br>QgBcklWstwoqdlOfinFeBOEi5kR6GsM78uBrfba2qI95DYFx0gYUcYbAhEufUHSa<br>JO4knxk3HqGPOe6hf4PBBoh/ymB9RxnpTm6JLZFmbKKqvYmyQonxnQju3irr81rk<br>S/wCSlrhWHcE84qT0XvXWKiaBBtG2qTbOtQNCkHAICmfEHSkYMFnAWugRpMVhBXN<br>LCxVxbzJoyXlGB0pm+ejvIFPCyWVhVjJKOku99ek///nf60IzEte6mPmTjnl9gtc<br>IiL3tHpM2d12L7/4lUCxvi9yoY47G0KrLmPv6M7cdky3Cr2Dzt4paCGkkepEEsa4<br>xhOyvwYUTuDLFY4yO3mFMxi4eV/xCz1IXo/BcQtGfbRdqjLnjA467YJViDZ/QRIJ<br>lAMroKsc/vWav1gpn1sO28FkgmeDXsLpxWhtodNejF3IXj0/C/QqbBREO3oe7wOu<br>kTKnP6ogpLbz5rr1SWKm0HFWXOK8ZGPEhYIVpL2Cm69fM97qgxPgJEGrasZBQiD6<br>JYpevtnUq/Us9VEiPIsSjPes/ePN+ztg1dsivYjDxTzZDD3IatMoYydiXe/SIVu4<br>hAB4vuXBulP0k1HE3lao<br>=zenR<br>-----END PGP SIGNATURE-----<br></div></div>