<div dir="ltr">Hi all,<div><br></div><div><div>On behalf of the <span class="gmail-il">SciPy</span> development team I'm pleased to announce</div><div>the release of <span class="gmail-il">SciPy</span> <span class="gmail-il">1.6</span>.<span class="gmail-il">0</span>.</div><div><br></div><div>Sources and binary wheels can be found at:<br><a href="https://pypi.org/project/scipy/" target="_blank">https://pypi.org/project/<span class="gmail-il">scipy</span>/</a><br>and at:<br><a href="https://github.com/scipy/scipy/releases/tag/v1.6.0">https://github.com/scipy/scipy/releases/tag/v1.6.0</a> <br><br>One of a few ways to install this release with pip:<br><br>pip install <span class="gmail-il">scipy</span>==<span class="gmail-il">1.6</span>.<span class="gmail-il">0</span></div></div><div><br></div><div><span class="gmail-il">=====================<br>SciPy 1.6.0 Release Notes<br>=====================<br><br>SciPy 1.6.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.6.x branch, and on adding new features on the master branch.<br><br>This release requires Python 3.7+ and NumPy 1.16.5 or greater.<br><br>For running on PyPy, PyPy3 6.0+ is required.<br><br>Highlights of this release<br>---------------------------------<br><br>-  `scipy.ndimage` improvements: Fixes and ehancements to boundary extension <br>  modes for interpolation functions. Support for complex-valued inputs in many<br>  filtering and interpolation functions. New ``grid_mode`` option for <br>  `scipy.ndimage.zoom` to enable results consistent with scikit-image's <br>  ``rescale``.<br>-  `scipy.optimize.linprog` has fast, new methods for large, sparse problems <br>  from the ``HiGHS`` library.<br>-  `scipy.stats` improvements including new distributions, a new test, and<br>  enhancements to existing distributions and tests<br><br><br>New features<br>==========<br><br>`scipy.special` improvements<br>---------------------------------------<br>`scipy.special` now has improved support for 64-bit ``LAPACK`` backend<br><br>`scipy.odr` improvements<br>----------------------------------<br>`scipy.odr` now has support for 64-bit integer ``BLAS``<br><br>`scipy.odr.ODR` has gained an optional ``overwrite`` argument so that existing<br>files may be overwritten.<br><br>`scipy.integrate` improvements<br>------------------------------------------<br>Some renames of functions with poor names were done, with the old names <br>retained without being in the reference guide for backwards compatibility <br>reasons:<br>-  ``integrate.simps`` was renamed to ``integrate.simpson``<br>-  ``integrate.trapz`` was renamed to ``integrate.trapezoid``<br>-  ``integrate.cumtrapz`` was renamed to ``integrate.cumulative_trapezoid``<br><br>`scipy.cluster` improvements<br>---------------------------------------<br>`scipy.cluster.hierarchy.DisjointSet` has been added for incremental <br>connectivity queries.<br><br>`scipy.cluster.hierarchy.dendrogram` return value now also includes leaf color<br>information in `leaves_color_list`.<br><br>`scipy.interpolate` improvements<br>--------------------------------------------<br>`scipy.interpolate.interp1d` has a new method ``nearest-up``, similar to the <br>existing method ``nearest`` but rounds half-integers up instead of down.<br><br>`<a href="http://scipy.io">scipy.io</a>` improvements<br>--------------------------------<br>Support has been added for reading arbitrary bit depth integer PCM WAV files <br>from 1- to 32-bit, including the commonly-requested 24-bit depth.<br><br>`scipy.linalg` improvements<br>-------------------------------------<br>The new function `scipy.linalg.matmul_toeplitz` uses the FFT to compute the <br>product of a Toeplitz matrix with another matrix.<br><br>`scipy.linalg.sqrtm` and `scipy.linalg.logm` have performance improvements<br>thanks to additional Cython code.<br><br>Python ``LAPACK`` wrappers have been added for ``pptrf``, ``pptrs``, ``ppsv``,<br>``pptri``, and ``ppcon``.<br><br>`scipy.linalg.norm` and the ``svd`` family of functions will now use 64-bit<br>integer backends when available.<br><br>`scipy.ndimage` improvements<br>------------------------------------------<br>`scipy.ndimage.convolve`, `scipy.ndimage.correlate` and their 1d counterparts <br>now accept both complex-valued images and/or complex-valued filter kernels. All <br>convolution-based filters also now accept complex-valued inputs <br>(e.g. ``gaussian_filter``, ``uniform_filter``, etc.).<br><br>Multiple fixes and enhancements to boundary handling were introduced to <br>`scipy.ndimage` interpolation functions (i.e. ``affine_transform``,<br>``geometric_transform``, ``map_coordinates``, ``rotate``, ``shift``, ``zoom``).<br><br>A new boundary mode, ``grid-wrap`` was added which wraps images periodically,<br>using a period equal to the shape of the input image grid. This is in contrast <br>to the existing ``wrap`` mode which uses a period that is one sample smaller <br>than the original signal extent along each dimension.<br><br>A long-standing bug in the ``reflect`` boundary condition has been fixed and <br>the mode ``grid-mirror`` was introduced as a synonym for ``reflect``.<br><br>A new boundary mode, ``grid-constant`` is now available. This is similar to <br>the existing ndimage ``constant`` mode, but interpolation will still performed <br>at coordinate values outside of the original image extent. This <br>``grid-constant`` mode is consistent with OpenCV's ``BORDER_CONSTANT`` mode <br>and scikit-image's ``constant`` mode.<br><br>Spline pre-filtering (used internally by ``ndimage`` interpolation functions <br>when ``order >= 2``), now supports all boundary modes rather than always <br>defaulting to mirror boundary conditions. The standalone functions <br>``spline_filter`` and ``spline_filter1d`` have analytical boundary conditions <br>that match modes ``mirror``, ``grid-wrap`` and ``reflect``.<br><br>`scipy.ndimage` interpolation functions now accept complex-valued inputs. In<br>this case, the interpolation is applied independently to the real and <br>imaginary components.<br><br>The ``ndimage`` tutorials <br>(<a href="https://docs.scipy.org/doc/scipy/reference/tutorial/ndimage.html">https://docs.scipy.org/doc/scipy/reference/tutorial/ndimage.html</a>) have been <br>updated with new figures to better clarify the exact behavior of all of the <br>interpolation boundary modes.<br><br>`scipy.ndimage.zoom` now has a ``grid_mode`` option that changes the coordinate <br>of the center of the first pixel along an axis from 0 to 0.5. This allows <br>resizing in a manner that is consistent with the behavior of scikit-image's <br>``resize`` and ``rescale`` functions (and OpenCV's ``cv2.resize``).<br><br>`scipy.optimize` improvements<br>-----------------------------------------<br>`scipy.optimize.linprog` has fast, new methods for large, sparse problems from <br>the ``HiGHS`` C++ library. ``method='highs-ds'`` uses a high performance dual <br>revised simplex implementation (HSOL), ``method='highs-ipm'`` uses an <br>interior-point method with crossover, and ``method='highs'`` chooses between <br>the two automatically. These methods are typically much faster and often exceed <br>the accuracy of other ``linprog`` methods, so we recommend explicitly <br>specifying one of these three method values when using ``linprog``.<br><br>`scipy.optimize.quadratic_assignment` has been added for approximate solution <br>of the quadratic assignment problem.<br><br>`scipy.optimize.linear_sum_assignment` now has a substantially reduced overhead<br>for small cost matrix sizes<br><br>`scipy.optimize.least_squares` has improved performance when the user provides<br>the jacobian as a sparse jacobian already in ``csr_matrix`` format<br><br>`scipy.optimize.linprog` now has an ``rr_method`` argument for specification<br>of the method used for redundancy handling, and a new method for this purpose<br>is available based on the interpolative decomposition approach.<br><br>`scipy.signal` improvements<br>--------------------------------------<br>`scipy.signal.gammatone` has been added to design FIR or IIR filters that <br>model the human auditory system.<br><br>`scipy.signal.iircomb` has been added to design IIR peaking/notching comb <br>filters that can boost/attenuate a frequency from a signal.<br><br>`scipy.signal.sosfilt` performance has been improved to avoid some previously-<br>observed slowdowns<br><br>`scipy.signal.windows.taylor` has been added--the Taylor window function is<br>commonly used in radar digital signal processing<br><br>`scipy.signal.gauss_spline` now supports ``list`` type input for consistency<br>with other related SciPy functions<br><br>`scipy.signal.correlation_lags` has been added to allow calculation of the lag/<br>displacement indices array for 1D cross-correlation.<br><br>`scipy.sparse` improvements<br>---------------------------------------<br>A solver for the minimum weight full matching problem for bipartite graphs,<br>also known as the linear assignment problem, has been added in<br>`scipy.sparse.csgraph.min_weight_full_bipartite_matching`. In particular, this<br>provides functionality analogous to that of<br>`scipy.optimize.linear_sum_assignment`, but with improved performance for sparse<br>inputs, and the ability to handle inputs whose dense representations would not<br>fit in memory.<br><br>The time complexity of `scipy.sparse.block_diag` has been improved dramatically<br>from quadratic to linear.<br><br>`scipy.sparse.linalg` improvements<br>-----------------------------------------------<br>The vendored version of ``SuperLU`` has been updated<br><br>`scipy.fft` improvements<br>--------------------------------<br><br>The vendored ``pocketfft`` library now supports compiling with ARM neon vector<br>extensions and has improved thread pool behavior.<br><br>`scipy.spatial` improvements<br>---------------------------------------<br>The python implementation of ``KDTree`` has been dropped and ``KDTree`` is now <br>implemented in terms of ``cKDTree``. You can now expect ``cKDTree``-like <br>performance by default. This also means ``sys.setrecursionlimit`` no longer <br>needs to be increased for querying large trees.<br><br>``transform.Rotation`` has been updated with support for Modified Rodrigues <br>Parameters alongside the existing rotation representations (PR gh-12667).<br><br>`scipy.spatial.transform.Rotation` has been partially cythonized, with some<br>performance improvements observed<br><br>`scipy.spatial.distance.cdist` has improved performance with the ``minkowski``<br>metric, especially for p-norm values of 1 or 2.<br><br>`scipy.stats` improvements<br>------------------------------------<br>New distributions have been added to `scipy.stats`:<br><br>-  The asymmetric Laplace continuous distribution has been added as <br>  `scipy.stats.laplace_asymmetric`.<br>-  The negative hypergeometric distribution has been added as `scipy.stats.nhypergeom`.<br>-  The multivariate t distribution has been added as `scipy.stats.multivariate_t`.<br>-  The multivariate hypergeometric distribution has been added as `scipy.stats.multivariate_hypergeom`.<br><br>The ``fit`` method has been overridden for several distributions (``laplace``,<br>``pareto``, ``rayleigh``, ``invgauss``, ``logistic``, ``gumbel_l``, <br>``gumbel_r``); they now use analytical, distribution-specific maximum <br>likelihood estimation results for greater speed and accuracy than the generic <br>(numerical optimization) implementation.<br><br>The one-sample Cramér-von Mises test has been added as <br>`scipy.stats.cramervonmises`.<br><br>An option to compute one-sided p-values was added to `scipy.stats.ttest_1samp`, <br>`scipy.stats.ttest_ind_from_stats`, `scipy.stats.ttest_ind` and <br>`scipy.stats.ttest_rel`.<br><br>The function `scipy.stats.kendalltau` now has an option to compute Kendall's <br>tau-c (also known as Stuart's tau-c), and support has been added for exact<br>p-value calculations for sample sizes ``> 171``.<br><br>`stats.trapz` was renamed to `stats.trapezoid`, with the former name retained <br>as an alias for backwards compatibility reasons.<br><br>The function `scipy.stats.linregress` now includes the standard error of the <br>intercept in its return value.<br><br>The ``_logpdf``, ``_sf``, and ``_isf`` methods have been added to<br>`scipy.stats.nakagami`; ``_sf`` and ``_isf`` methods also added to<br>`scipy.stats.gumbel_r`<br><br>The ``sf`` method has been added to `scipy.stats.levy` and `scipy.stats.levy_l`<br>for improved precision.<br><br>`scipy.stats.binned_statistic_dd` performance improvements for the following<br>computed statistics: ``max``, ``min``, ``median``, and ``std``.<br><br>We gratefully acknowledge the Chan-Zuckerberg Initiative Essential Open Source <br>Software for Science program for supporting many of these improvements to <br>`scipy.stats`.<br><br>Deprecated features<br>================<br><br>`scipy.spatial` changes<br>-------------------------------<br>Calling ``KDTree.query`` with ``k=None`` to find all neighbours is deprecated. <br>Use ``KDTree.query_ball_point`` instead.<br><br>``distance.wminkowski`` was deprecated; use ``distance.minkowski`` and supply <br>weights with the ``w`` keyword instead.<br><br>Backwards incompatible changes<br>==========================<br><br>`scipy` changes<br>---------------------<br>Using `scipy.fft` as a function aliasing ``numpy.fft.fft`` was removed after <br>being deprecated in SciPy ``1.4.0``. As a result, the `scipy.fft` submodule <br>must be explicitly imported now, in line with other SciPy subpackages.<br><br>`scipy.signal` changes<br>-------------------------------<br>The output of ``decimate``, ``lfilter_zi``, ``lfiltic``, ``sos2tf``, and <br>``sosfilt_zi`` have been changed to match ``numpy.result_type`` of their inputs. <br><br>The window function ``slepian`` was removed. It had been deprecated since SciPy <br>``1.1``.<br><br>`scipy.spatial` changes<br>-------------------------------<br>``cKDTree.query`` now returns 64-bit rather than 32-bit integers on Windows,<br>making behaviour consistent between platforms (PR gh-12673).<br><br><br>`scipy.stats` changes<br>-----------------------------<br>The ``frechet_l`` and ``frechet_r`` distributions were removed. They were <br>deprecated since SciPy ``1.0``.<br><br>Other changes<br>=============<br>``setup_requires`` was removed from ``setup.py``. This means that users <br>invoking ``python setup.py install`` without having numpy already installed <br>will now get an error, rather than having numpy installed for them via <br>``easy_install``. This install method was always fragile and problematic, users <br>are encouraged to use ``pip`` when installing from source.<br><br>-  Fixed a bug in `scipy.optimize.dual_annealing` ``accept_reject`` calculation <br>  that caused uphill jumps to be accepted less frequently.<br>-  The time required for (un)pickling of `scipy.stats.rv_continuous`, <br>  `scipy.stats.rv_discrete`, and `scipy.stats.rv_frozen` has been significantly<br>  reduced (gh12550). Inheriting subclasses should note that ``__setstate__`` no <br>  longer calls ``__init__`` upon unpickling.<br><br>Authors<br>=======<br><br>* @endolith<br>* @vkk800<br>* aditya +<br>* George Bateman +<br>* Christoph Baumgarten<br>* Peter Bell<br>* Tobias Biester +<br>* Keaton J. Burns +<br>* Evgeni Burovski<br>* Rüdiger Busche +<br>* Matthias Bussonnier<br>* Dominic C +<br>* Corallus Caninus +<br>* CJ Carey<br>* Thomas A Caswell<br>* chapochn +<br>* Lucía Cheung<br>* Zach Colbert +<br>* Coloquinte +<br>* Yannick Copin +<br>* Devin Crowley +<br>* Terry Davis +<br>* Michaël Defferrard +<br>* devonwp +<br>* Didier +<br>* divenex +<br>* Thomas Duvernay +<br>* Eoghan O'Connell +<br>* Gökçen Eraslan<br>* Kristian Eschenburg +<br>* Ralf Gommers<br>* Thomas Grainger +<br>* GreatV +<br>* Gregory Gundersen +<br>* h-vetinari +<br>* Matt Haberland<br>* Mark Harfouche +<br>* He He +<br>* Alex Henrie<br>* Chun-Ming Huang +<br>* Martin James McHugh III +<br>* Alex Izvorski +<br>* Joey +<br>* ST John +<br>* Jonas Jonker +<br>* Julius Bier Kirkegaard<br>* Marcin Konowalczyk +<br>* Konrad0<br>* Sam Van Kooten +<br>* Sergey Koposov +<br>* Peter Mahler Larsen<br>* Eric Larson<br>* Antony Lee<br>* Gregory R. Lee<br>* Loïc Estève<br>* Jean-Luc Margot +<br>* MarkusKoebis +<br>* Nikolay Mayorov<br>* G. D. McBain<br>* Andrew McCluskey +<br>* Nicholas McKibben<br>* Sturla Molden<br>* Denali Molitor +<br>* Eric Moore<br>* Shashaank N +<br>* Prashanth Nadukandi +<br>* nbelakovski +<br>* Andrew Nelson<br>* Nick +<br>* Nikola Forró +<br>* odidev<br>* ofirr +<br>* Sambit Panda<br>* Dima Pasechnik<br>* Tirth Patel +<br>* Matti Picus<br>* Paweł Redzyński +<br>* Vladimir Philipenko +<br>* Philipp Thölke +<br>* Ilhan Polat<br>* Eugene Prilepin +<br>* Vladyslav Rachek<br>* Ram Rachum +<br>* Tyler Reddy<br>* Martin Reinecke +<br>* Simon Segerblom Rex +<br>* Lucas Roberts<br>* Benjamin Rowell +<br>* Eli Rykoff +<br>* Atsushi Sakai<br>* Moritz Schulte +<br>* Daniel B. Smith<br>* Steve Smith +<br>* Jan Soedingrekso +<br>* Victor Stinner +<br>* Jose Storopoli +<br>* Diana Sukhoverkhova +<br>* Søren Fuglede Jørgensen<br>* taoky +<br>* Mike Taves +<br>* Ian Thomas +<br>* Will Tirone +<br>* Frank Torres +<br>* Seth Troisi<br>* Ronald van Elburg +<br>* Hugo van Kemenade<br>* Paul van Mulbregt<br>* Saul Ivan Rivas Vega +<br>* Pauli Virtanen<br>* Jan Vleeshouwers<br>* Samuel Wallan<br>* Warren Weckesser<br>* Ben West +<br>* Eric Wieser<br>* WillTirone +<br>* Levi John Wolf +<br>* Zhiqing Xiao<br>* Rory Yorke +<br>* Yun Wang (Maigo) +<br>* Egor Zemlyanoy +<br>* ZhihuiChen0903 +<br>* Jacob Zhong +<br><br>A total of 122 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>Issues closed for 1.6.0<br>-------------------------------<br><br>* `#1323 <<a href="https://github.com/scipy/scipy/issues/1323">https://github.com/scipy/scipy/issues/1323</a>>`__: ndimage.shift destroys data from edges (Trac #796)<br>* `#1892 <<a href="https://github.com/scipy/scipy/issues/1892">https://github.com/scipy/scipy/issues/1892</a>>`__: using rptfile= with an existing file causes a Fortran runtime...<br>* `#1903 <<a href="https://github.com/scipy/scipy/issues/1903">https://github.com/scipy/scipy/issues/1903</a>>`__: ndimage.rotate misses some values (Trac #1378)<br>* `#1930 <<a href="https://github.com/scipy/scipy/issues/1930">https://github.com/scipy/scipy/issues/1930</a>>`__: scipy.io.wavfile should be able to read 24 bit signed wave (Trac...<br>* `#3158 <<a href="https://github.com/scipy/scipy/issues/3158">https://github.com/scipy/scipy/issues/3158</a>>`__: Odd casting behaviour of signal.filtfilt<br>* `#3203 <<a href="https://github.com/scipy/scipy/issues/3203">https://github.com/scipy/scipy/issues/3203</a>>`__: interpolation.zoom incorrect output for certain cases<br>* `#3645 <<a href="https://github.com/scipy/scipy/issues/3645">https://github.com/scipy/scipy/issues/3645</a>>`__: BUG: stats: mstats.pearsonr calculation is wrong if the masks...<br>* `#3665 <<a href="https://github.com/scipy/scipy/issues/3665">https://github.com/scipy/scipy/issues/3665</a>>`__: Return Bunch objects from stats functions<br>* `#4922 <<a href="https://github.com/scipy/scipy/issues/4922">https://github.com/scipy/scipy/issues/4922</a>>`__: unexpected zero output values from zoom<br>* `#5202 <<a href="https://github.com/scipy/scipy/issues/5202">https://github.com/scipy/scipy/issues/5202</a>>`__: BUG: stats: Spurious warnings from the pdf method of several...<br>* `#5223 <<a href="https://github.com/scipy/scipy/issues/5223">https://github.com/scipy/scipy/issues/5223</a>>`__: Zoom does not return the same values when resizing a sub-array...<br>* `#5396 <<a href="https://github.com/scipy/scipy/issues/5396">https://github.com/scipy/scipy/issues/5396</a>>`__: scipy.spatial.distance.pdist documention bug<br>* `#5489 <<a href="https://github.com/scipy/scipy/issues/5489">https://github.com/scipy/scipy/issues/5489</a>>`__: ValueError: failed to create intent(cache|hide)|optional array--...<br>* `#6096 <<a href="https://github.com/scipy/scipy/issues/6096">https://github.com/scipy/scipy/issues/6096</a>>`__: loadmat drops dtype of empty arrays when squeeze_me=True<br>* `#6713 <<a href="https://github.com/scipy/scipy/issues/6713">https://github.com/scipy/scipy/issues/6713</a>>`__: sicpy.ndimage.zoom returns artefacts and boundaries in some cases<br>* `#7125 <<a href="https://github.com/scipy/scipy/issues/7125">https://github.com/scipy/scipy/issues/7125</a>>`__: Impossible to know number of dimensions in c function used by...<br>* `#7324 <<a href="https://github.com/scipy/scipy/issues/7324">https://github.com/scipy/scipy/issues/7324</a>>`__: scipy.ndimage.zoom bad interpolation when downsampling (zoom...<br>* `#8131 <<a href="https://github.com/scipy/scipy/issues/8131">https://github.com/scipy/scipy/issues/8131</a>>`__: BUG: geometric_transform wrap mode possible bug<br>* `#8163 <<a href="https://github.com/scipy/scipy/issues/8163">https://github.com/scipy/scipy/issues/8163</a>>`__: LSMR fails on some random values when providing an x0<br>* `#8210 <<a href="https://github.com/scipy/scipy/issues/8210">https://github.com/scipy/scipy/issues/8210</a>>`__: Why should I choose order > 1 for scipy.ndimage.zoom?<br>* `#8465 <<a href="https://github.com/scipy/scipy/issues/8465">https://github.com/scipy/scipy/issues/8465</a>>`__: Unexpected behavior with reflect mode of ndimage.rotate<br>* `#8776 <<a href="https://github.com/scipy/scipy/issues/8776">https://github.com/scipy/scipy/issues/8776</a>>`__: cdist behavior with Minkowsky and np.inf<br>* `#9168 <<a href="https://github.com/scipy/scipy/issues/9168">https://github.com/scipy/scipy/issues/9168</a>>`__: documentation of pearson3 in scipy.stats unclear<br>* `#9223 <<a href="https://github.com/scipy/scipy/issues/9223">https://github.com/scipy/scipy/issues/9223</a>>`__: Faster implementation of scipy.sparse.block_diag<br>* `#9476 <<a href="https://github.com/scipy/scipy/issues/9476">https://github.com/scipy/scipy/issues/9476</a>>`__: Invalid index in signal.medfilt2d's QUICK_SELECT<br>* `#9857 <<a href="https://github.com/scipy/scipy/issues/9857">https://github.com/scipy/scipy/issues/9857</a>>`__: scipy.odr.Output.sd_beta is not standard error<br>* `#9865 <<a href="https://github.com/scipy/scipy/issues/9865">https://github.com/scipy/scipy/issues/9865</a>>`__: Strange behavior of \`ndimage.shift\` and \`ndimage.affine_transform\`<br>* `#10042 <<a href="https://github.com/scipy/scipy/issues/10042">https://github.com/scipy/scipy/issues/10042</a>>`__: Consider support for multivariate student-t distribution?<br>* `#10134 <<a href="https://github.com/scipy/scipy/issues/10134">https://github.com/scipy/scipy/issues/10134</a>>`__: gausshyper distribution accepts invalid parameters<br>* `#10179 <<a href="https://github.com/scipy/scipy/issues/10179">https://github.com/scipy/scipy/issues/10179</a>>`__: str+bytes concatenation error in test_lapack.py<br>* `#10216 <<a href="https://github.com/scipy/scipy/issues/10216">https://github.com/scipy/scipy/issues/10216</a>>`__: cKDTree.query_ball_point speed regression<br>* `#10463 <<a href="https://github.com/scipy/scipy/issues/10463">https://github.com/scipy/scipy/issues/10463</a>>`__: ENH: vectorize scipy.fft for more CPU architectures<br>* `#10593 <<a href="https://github.com/scipy/scipy/issues/10593">https://github.com/scipy/scipy/issues/10593</a>>`__: Rename \`sum\` ndimage function<br>* `#10595 <<a href="https://github.com/scipy/scipy/issues/10595">https://github.com/scipy/scipy/issues/10595</a>>`__: scipy.stats.ttest_1samp should support alternative hypothesis<br>* `#10610 <<a href="https://github.com/scipy/scipy/issues/10610">https://github.com/scipy/scipy/issues/10610</a>>`__: ndimage.interpolation.spline_filter1d default value of mode<br>* `#10620 <<a href="https://github.com/scipy/scipy/issues/10620">https://github.com/scipy/scipy/issues/10620</a>>`__: ndimage.interpolation.zoom() option to work like skimage.transform.resize()<br>* `#10711 <<a href="https://github.com/scipy/scipy/issues/10711">https://github.com/scipy/scipy/issues/10711</a>>`__: Array Shapes Not Aligned Bug in scipy.optimize._<a href="http://lsq.lsq_linear.py">lsq.lsq_linear.py</a><br>* `#10782 <<a href="https://github.com/scipy/scipy/issues/10782">https://github.com/scipy/scipy/issues/10782</a>>`__: BUG: optimize: methods unknown to \`scipy.optimize.show_options\`<br>* `#10892 <<a href="https://github.com/scipy/scipy/issues/10892">https://github.com/scipy/scipy/issues/10892</a>>`__: Possible typo in an equation of optimize/dual_annealing<br>* `#11020 <<a href="https://github.com/scipy/scipy/issues/11020">https://github.com/scipy/scipy/issues/11020</a>>`__: signal.fftconvolve return a tuple including lag information<br>* `#11093 <<a href="https://github.com/scipy/scipy/issues/11093">https://github.com/scipy/scipy/issues/11093</a>>`__: scipy.interpolate.interp1d can not handle datetime64<br>* `#11170 <<a href="https://github.com/scipy/scipy/issues/11170">https://github.com/scipy/scipy/issues/11170</a>>`__: Use manylinux2014 to get aarch64/ppc64le support<br>* `#11186 <<a href="https://github.com/scipy/scipy/issues/11186">https://github.com/scipy/scipy/issues/11186</a>>`__: BUG: stats: pearson3 CDF and SF functions incorrect when skew...<br>* `#11366 <<a href="https://github.com/scipy/scipy/issues/11366">https://github.com/scipy/scipy/issues/11366</a>>`__: DeprecationWarning due to invalid escape sequences<br>* `#11403 <<a href="https://github.com/scipy/scipy/issues/11403">https://github.com/scipy/scipy/issues/11403</a>>`__: Optimize raises "ValueError: \`x0\` violates bound constraints"...<br>* `#11558 <<a href="https://github.com/scipy/scipy/issues/11558">https://github.com/scipy/scipy/issues/11558</a>>`__: ENH: IIR comb filter<br>* `#11559 <<a href="https://github.com/scipy/scipy/issues/11559">https://github.com/scipy/scipy/issues/11559</a>>`__: BUG: iirdesign doesn't fail for frequencies above Nyquist<br>* `#11567 <<a href="https://github.com/scipy/scipy/issues/11567">https://github.com/scipy/scipy/issues/11567</a>>`__: scipy.signal.iirdesign doesn't check consistency of wp and ws...<br>* `#11654 <<a href="https://github.com/scipy/scipy/issues/11654">https://github.com/scipy/scipy/issues/11654</a>>`__: ENH: Add Negative Hypergeometric Distribution<br>* `#11720 <<a href="https://github.com/scipy/scipy/issues/11720">https://github.com/scipy/scipy/issues/11720</a>>`__: BUG: stats: wrong shape from median_absolute_deviation for arrays...<br>* `#11746 <<a href="https://github.com/scipy/scipy/issues/11746">https://github.com/scipy/scipy/issues/11746</a>>`__: BUG: stats: pearson3 returns size 1 arrays where other distributions...<br>* `#11756 <<a href="https://github.com/scipy/scipy/issues/11756">https://github.com/scipy/scipy/issues/11756</a>>`__: Improve and fix \*Spline docstrings and code<br>* `#11758 <<a href="https://github.com/scipy/scipy/issues/11758">https://github.com/scipy/scipy/issues/11758</a>>`__: BUG: of scipy.interpolate.CubicSpline when \`bc_type' is set...<br>* `#11925 <<a href="https://github.com/scipy/scipy/issues/11925">https://github.com/scipy/scipy/issues/11925</a>>`__: MAINT: remove character encoding check in CI?<br>* `#11963 <<a href="https://github.com/scipy/scipy/issues/11963">https://github.com/scipy/scipy/issues/11963</a>>`__: Test failures - TestLinprogIPSparseCholmod<br>* `#12102 <<a href="https://github.com/scipy/scipy/issues/12102">https://github.com/scipy/scipy/issues/12102</a>>`__: incorrect first moment of non central t-distribution<br>* `#12113 <<a href="https://github.com/scipy/scipy/issues/12113">https://github.com/scipy/scipy/issues/12113</a>>`__: scipy.stats.poisson docs for rate = 0<br>* `#12152 <<a href="https://github.com/scipy/scipy/issues/12152">https://github.com/scipy/scipy/issues/12152</a>>`__: ENH: signal.gauss_spline should accept a list<br>* `#12157 <<a href="https://github.com/scipy/scipy/issues/12157">https://github.com/scipy/scipy/issues/12157</a>>`__: BUG: Iteration index initialisation is wrong in scipy.optimize.linesearch.scalar_search_wolfe2<br>* `#12162 <<a href="https://github.com/scipy/scipy/issues/12162">https://github.com/scipy/scipy/issues/12162</a>>`__: Storing Rotation object in NumPy array returns an array with...<br>* `#12176 <<a href="https://github.com/scipy/scipy/issues/12176">https://github.com/scipy/scipy/issues/12176</a>>`__: cannot modify the slice of an array returned by \`wavfile.read\`<br>* `#12190 <<a href="https://github.com/scipy/scipy/issues/12190">https://github.com/scipy/scipy/issues/12190</a>>`__: retrieve leave colors from dendrogram<br>* `#12196 <<a href="https://github.com/scipy/scipy/issues/12196">https://github.com/scipy/scipy/issues/12196</a>>`__: PERF: scipy.linalg.pinv is very slow compared to numpy.linalg.pinv<br>* `#12222 <<a href="https://github.com/scipy/scipy/issues/12222">https://github.com/scipy/scipy/issues/12222</a>>`__: Interpolating categorical data (interp1d)<br>* `#12231 <<a href="https://github.com/scipy/scipy/issues/12231">https://github.com/scipy/scipy/issues/12231</a>>`__: Is the p-value of the Kruskal-Wallis test two-sided?<br>* `#12249 <<a href="https://github.com/scipy/scipy/issues/12249">https://github.com/scipy/scipy/issues/12249</a>>`__: ENH: least_squares: should not re-instanciate csr_matrix if already...<br>* `#12264 <<a href="https://github.com/scipy/scipy/issues/12264">https://github.com/scipy/scipy/issues/12264</a>>`__: DOC: optimize: linprog method-specific function signature<br>* `#12290 <<a href="https://github.com/scipy/scipy/issues/12290">https://github.com/scipy/scipy/issues/12290</a>>`__: DOC: Convex Hull areas are actually perimeters for 2-dimensional...<br>* `#12308 <<a href="https://github.com/scipy/scipy/issues/12308">https://github.com/scipy/scipy/issues/12308</a>>`__: integrate.solve_ivp with DOP853 method fails when yDot = 0<br>* `#12326 <<a href="https://github.com/scipy/scipy/issues/12326">https://github.com/scipy/scipy/issues/12326</a>>`__: BUG: stats.exponnorm.pdf returns 0 for small K<br>* `#12337 <<a href="https://github.com/scipy/scipy/issues/12337">https://github.com/scipy/scipy/issues/12337</a>>`__: scipy.sparse.linalg.eigsh documentation is misleading<br>* `#12339 <<a href="https://github.com/scipy/scipy/issues/12339">https://github.com/scipy/scipy/issues/12339</a>>`__: scipy.io.wavfile.write documentation has wrong example<br>* `#12340 <<a href="https://github.com/scipy/scipy/issues/12340">https://github.com/scipy/scipy/issues/12340</a>>`__: sparse.lil_matrix.tocsr() fails silently on matrices with nzn...<br>* `#12350 <<a href="https://github.com/scipy/scipy/issues/12350">https://github.com/scipy/scipy/issues/12350</a>>`__: Create a 2-parameter version of the gamma distribution<br>* `#12369 <<a href="https://github.com/scipy/scipy/issues/12369">https://github.com/scipy/scipy/issues/12369</a>>`__: scipy.signal.correlate has an error in the documentation, examples...<br>* `#12373 <<a href="https://github.com/scipy/scipy/issues/12373">https://github.com/scipy/scipy/issues/12373</a>>`__: interp1d returns incorrect values for step functions<br>* `#12378 <<a href="https://github.com/scipy/scipy/issues/12378">https://github.com/scipy/scipy/issues/12378</a>>`__: interpolate.NearestNDInterpolator.__call__ & LinearNDInterpolator.__call__...<br>* `#12411 <<a href="https://github.com/scipy/scipy/issues/12411">https://github.com/scipy/scipy/issues/12411</a>>`__: scipy.stats.spearmanr mishandles nan variables with "propogate"<br>* `#12413 <<a href="https://github.com/scipy/scipy/issues/12413">https://github.com/scipy/scipy/issues/12413</a>>`__: DOC: Remove the "Basic functions" section from the SciPy tutorial.<br>* `#12415 <<a href="https://github.com/scipy/scipy/issues/12415">https://github.com/scipy/scipy/issues/12415</a>>`__: scipy.stats.dirichlet documentation issue<br>* `#12419 <<a href="https://github.com/scipy/scipy/issues/12419">https://github.com/scipy/scipy/issues/12419</a>>`__: least_squares ValueError with 'lm' method - regression from 1.4.1...<br>* `#12431 <<a href="https://github.com/scipy/scipy/issues/12431">https://github.com/scipy/scipy/issues/12431</a>>`__: Request for Python wrapper for LAPACK's ?pptrf (Cholesky factorization...<br>* `#12458 <<a href="https://github.com/scipy/scipy/issues/12458">https://github.com/scipy/scipy/issues/12458</a>>`__: spearmanr with entire NaN columns produces errors<br>* `#12477 <<a href="https://github.com/scipy/scipy/issues/12477">https://github.com/scipy/scipy/issues/12477</a>>`__: WIP: Addition of MLE for stats.invgauss/wald<br>* `#12483 <<a href="https://github.com/scipy/scipy/issues/12483">https://github.com/scipy/scipy/issues/12483</a>>`__: reading .wav fails when the file is too big on python 3.6.0<br>* `#12490 <<a href="https://github.com/scipy/scipy/issues/12490">https://github.com/scipy/scipy/issues/12490</a>>`__: BUG: stats: logistic and genlogistic logpdf overflow for large...<br>* `#12499 <<a href="https://github.com/scipy/scipy/issues/12499">https://github.com/scipy/scipy/issues/12499</a>>`__: LinearNDInterpolator raises ValueError when value array has writeable=False...<br>* `#12523 <<a href="https://github.com/scipy/scipy/issues/12523">https://github.com/scipy/scipy/issues/12523</a>>`__: Wrong key in __odrpack.c<br>* `#12547 <<a href="https://github.com/scipy/scipy/issues/12547">https://github.com/scipy/scipy/issues/12547</a>>`__: typo in scipy/cluster/_hierarchy.pyx<br>* `#12549 <<a href="https://github.com/scipy/scipy/issues/12549">https://github.com/scipy/scipy/issues/12549</a>>`__: DOC: least_squares return type is poorly formatted.<br>* `#12578 <<a href="https://github.com/scipy/scipy/issues/12578">https://github.com/scipy/scipy/issues/12578</a>>`__: TST: test_bounds_infeasible_2 failing on wheels repo cron jobs<br>* `#12585 <<a href="https://github.com/scipy/scipy/issues/12585">https://github.com/scipy/scipy/issues/12585</a>>`__: ENH: Add Multivariate Hypergeometric Distribution<br>* `#12604 <<a href="https://github.com/scipy/scipy/issues/12604">https://github.com/scipy/scipy/issues/12604</a>>`__: unintuitive conversion in \`scipy.constants.lambda2nu\`<br>* `#12606 <<a href="https://github.com/scipy/scipy/issues/12606">https://github.com/scipy/scipy/issues/12606</a>>`__: DOC: Invalid syntax in example.<br>* `#12665 <<a href="https://github.com/scipy/scipy/issues/12665">https://github.com/scipy/scipy/issues/12665</a>>`__: List of possible bugs found by automated code analysis<br>* `#12696 <<a href="https://github.com/scipy/scipy/issues/12696">https://github.com/scipy/scipy/issues/12696</a>>`__: scipy.optimize.fminbound, numpy depreciation warning Creating...<br>* `#12699 <<a href="https://github.com/scipy/scipy/issues/12699">https://github.com/scipy/scipy/issues/12699</a>>`__: TestProjections.test_iterative_refinements_dense failure<br>* `#12701 <<a href="https://github.com/scipy/scipy/issues/12701">https://github.com/scipy/scipy/issues/12701</a>>`__: TestDifferentialEvolutionSolver::test_L4 failing<br>* `#12719 <<a href="https://github.com/scipy/scipy/issues/12719">https://github.com/scipy/scipy/issues/12719</a>>`__: Misleading scipy.signal.get_window() docstring with 'exponential'...<br>* `#12740 <<a href="https://github.com/scipy/scipy/issues/12740">https://github.com/scipy/scipy/issues/12740</a>>`__: circstd doesn't handle R = hypot(S, C) > 1<br>* `#12749 <<a href="https://github.com/scipy/scipy/issues/12749">https://github.com/scipy/scipy/issues/12749</a>>`__: ENH: interp1d Matlab compatibility<br>* `#12773 <<a href="https://github.com/scipy/scipy/issues/12773">https://github.com/scipy/scipy/issues/12773</a>>`__: Meta-issue: ndimage spline boundary handling (NumFOCUS proposal)<br>* `#12813 <<a href="https://github.com/scipy/scipy/issues/12813">https://github.com/scipy/scipy/issues/12813</a>>`__: optimize.root(method="krylov") fails if options["tol_norm"] expects...<br>* `#12815 <<a href="https://github.com/scipy/scipy/issues/12815">https://github.com/scipy/scipy/issues/12815</a>>`__: stats.zscore inconsistent behavior when all values are the same<br>* `#12840 <<a href="https://github.com/scipy/scipy/issues/12840">https://github.com/scipy/scipy/issues/12840</a>>`__: scipy.signal.windows.dpss docstring typo<br>* `#12874 <<a href="https://github.com/scipy/scipy/issues/12874">https://github.com/scipy/scipy/issues/12874</a>>`__: Rotation.random vs stats.special_ortho_group<br>* `#12881 <<a href="https://github.com/scipy/scipy/issues/12881">https://github.com/scipy/scipy/issues/12881</a>>`__: FFT - documentation - examples - linspace construction<br>* `#12904 <<a href="https://github.com/scipy/scipy/issues/12904">https://github.com/scipy/scipy/issues/12904</a>>`__: BUG: parsing in loadarff()<br>* `#12917 <<a href="https://github.com/scipy/scipy/issues/12917">https://github.com/scipy/scipy/issues/12917</a>>`__: GitHub Actions nightly build triggered on forks<br>* `#12919 <<a href="https://github.com/scipy/scipy/issues/12919">https://github.com/scipy/scipy/issues/12919</a>>`__: BUG: numerical precision, use gammaln in nct.mean<br>* `#12924 <<a href="https://github.com/scipy/scipy/issues/12924">https://github.com/scipy/scipy/issues/12924</a>>`__: Rename Sample Based Integration Methods to Comply with Code of...<br>* `#12940 <<a href="https://github.com/scipy/scipy/issues/12940">https://github.com/scipy/scipy/issues/12940</a>>`__: Should the minimum numpy for AIX be bumped to 1.16.5<br>* `#12951 <<a href="https://github.com/scipy/scipy/issues/12951">https://github.com/scipy/scipy/issues/12951</a>>`__: A possible typo in scipy.stats.weightedtau<br>* `#12952 <<a href="https://github.com/scipy/scipy/issues/12952">https://github.com/scipy/scipy/issues/12952</a>>`__: [Documentation question] Would it be more precise to specify...<br>* `#12970 <<a href="https://github.com/scipy/scipy/issues/12970">https://github.com/scipy/scipy/issues/12970</a>>`__: Documentation presents second order sections as the correct choice...<br>* `#12982 <<a href="https://github.com/scipy/scipy/issues/12982">https://github.com/scipy/scipy/issues/12982</a>>`__: Calculate standard error of the intercept in linregress<br>* `#12985 <<a href="https://github.com/scipy/scipy/issues/12985">https://github.com/scipy/scipy/issues/12985</a>>`__: Possible wrong link in scipy.stats.wilcoxon doc<br>* `#12991 <<a href="https://github.com/scipy/scipy/issues/12991">https://github.com/scipy/scipy/issues/12991</a>>`__: least_squares broken with float32<br>* `#13001 <<a href="https://github.com/scipy/scipy/issues/13001">https://github.com/scipy/scipy/issues/13001</a>>`__: \`OptimizeResult.message\` from \`L-BFGS-B\` is a bytes, not...<br>* `#13030 <<a href="https://github.com/scipy/scipy/issues/13030">https://github.com/scipy/scipy/issues/13030</a>>`__: BUG: lint_diff.py still fails for backport PRs<br>* `#13077 <<a href="https://github.com/scipy/scipy/issues/13077">https://github.com/scipy/scipy/issues/13077</a>>`__: CI: codecov proper patch diffs<br>* `#13085 <<a href="https://github.com/scipy/scipy/issues/13085">https://github.com/scipy/scipy/issues/13085</a>>`__: Build failing on main branch after HiGHS solver merge<br>* `#13088 <<a href="https://github.com/scipy/scipy/issues/13088">https://github.com/scipy/scipy/issues/13088</a>>`__: BLD, BUG: wheel builds failure with HiGHS/optimize<br>* `#13099 <<a href="https://github.com/scipy/scipy/issues/13099">https://github.com/scipy/scipy/issues/13099</a>>`__: Wrong output format for empty sparse results of kron<br>* `#13108 <<a href="https://github.com/scipy/scipy/issues/13108">https://github.com/scipy/scipy/issues/13108</a>>`__: TST, CI: GitHub Actions MacOS Failures<br>* `#13111 <<a href="https://github.com/scipy/scipy/issues/13111">https://github.com/scipy/scipy/issues/13111</a>>`__: BUG, DOC: refguide check is failing<br>* `#13127 <<a href="https://github.com/scipy/scipy/issues/13127">https://github.com/scipy/scipy/issues/13127</a>>`__: ODR output file writing broken in conda env with system compilers<br>* `#13134 <<a href="https://github.com/scipy/scipy/issues/13134">https://github.com/scipy/scipy/issues/13134</a>>`__: FromTravis migration tracker<br>* `#13140 <<a href="https://github.com/scipy/scipy/issues/13140">https://github.com/scipy/scipy/issues/13140</a>>`__: BUG: signal: \`ss2tf\` incorrectly truncates output to integers.<br>* `#13179 <<a href="https://github.com/scipy/scipy/issues/13179">https://github.com/scipy/scipy/issues/13179</a>>`__: CI: lint is failing because of output to stderr<br>* `#13182 <<a href="https://github.com/scipy/scipy/issues/13182">https://github.com/scipy/scipy/issues/13182</a>>`__: Key appears twice in \`test_optimize.test_show_options\`<br>* `#13191 <<a href="https://github.com/scipy/scipy/issues/13191">https://github.com/scipy/scipy/issues/13191</a>>`__: \`scipy.linalg.lapack.dgesjv\` overwrites original arrays if...<br>* `#13207 <<a href="https://github.com/scipy/scipy/issues/13207">https://github.com/scipy/scipy/issues/13207</a>>`__: TST: Erratic test failure in test_cossin_separate<br>* `#13221 <<a href="https://github.com/scipy/scipy/issues/13221">https://github.com/scipy/scipy/issues/13221</a>>`__: BUG: pavement.py glitch<br>* `#13239 <<a href="https://github.com/scipy/scipy/issues/13239">https://github.com/scipy/scipy/issues/13239</a>>`__: Segmentation fault with \`eigh(..., driver="evx")\` for 10x10...<br>* `#13248 <<a href="https://github.com/scipy/scipy/issues/13248">https://github.com/scipy/scipy/issues/13248</a>>`__: ndimage: improper cval handling for complex-valued inputs<br><br>Pull requests for 1.6.0<br>------------------------------<br><br>* `#8032 <<a href="https://github.com/scipy/scipy/pull/8032">https://github.com/scipy/scipy/pull/8032</a>>`__: ENH: Add in taylor window common in Radar processing<br>* `#8779 <<a href="https://github.com/scipy/scipy/pull/8779">https://github.com/scipy/scipy/pull/8779</a>>`__: CI: Run benchmarks<br>* `#9361 <<a href="https://github.com/scipy/scipy/pull/9361">https://github.com/scipy/scipy/pull/9361</a>>`__: ENH: Add Kendall's tau-a and tau-c variants to scipy.stats.kendalltau()<br>* `#11068 <<a href="https://github.com/scipy/scipy/pull/11068">https://github.com/scipy/scipy/pull/11068</a>>`__: ENH: Adds correlation_lags function to scipy.signal<br>* `#11119 <<a href="https://github.com/scipy/scipy/pull/11119">https://github.com/scipy/scipy/pull/11119</a>>`__: ENH: add Cramer-von-Mises (one-sample) test to scipy.stats<br>* `#11249 <<a href="https://github.com/scipy/scipy/pull/11249">https://github.com/scipy/scipy/pull/11249</a>>`__: ENH: optimize: interpolative decomposition redundancy removal...<br>* `#11346 <<a href="https://github.com/scipy/scipy/pull/11346">https://github.com/scipy/scipy/pull/11346</a>>`__: ENH: add fast toeplitz matrix multiplication using FFT<br>* `#11413 <<a href="https://github.com/scipy/scipy/pull/11413">https://github.com/scipy/scipy/pull/11413</a>>`__: ENH: Multivariate t-distribution (stale)<br>* `#11563 <<a href="https://github.com/scipy/scipy/pull/11563">https://github.com/scipy/scipy/pull/11563</a>>`__: ENH: exact p-value in stats.kendalltau() for sample sizes > 171<br>* `#11691 <<a href="https://github.com/scipy/scipy/pull/11691">https://github.com/scipy/scipy/pull/11691</a>>`__: ENH: add a stack of reversal functions to linprog<br>* `#12043 <<a href="https://github.com/scipy/scipy/pull/12043">https://github.com/scipy/scipy/pull/12043</a>>`__: ENH: optimize: add HiGHS methods to linprog - continued<br>* `#12061 <<a href="https://github.com/scipy/scipy/pull/12061">https://github.com/scipy/scipy/pull/12061</a>>`__: Check parameter consistensy in signal.iirdesign<br>* `#12067 <<a href="https://github.com/scipy/scipy/pull/12067">https://github.com/scipy/scipy/pull/12067</a>>`__: MAINT: Cleanup OLDAPI in ndimage/src/_ctest.c<br>* `#12069 <<a href="https://github.com/scipy/scipy/pull/12069">https://github.com/scipy/scipy/pull/12069</a>>`__: DOC: Add developer guidelines for implementing the nan_policy...<br>* `#12077 <<a href="https://github.com/scipy/scipy/pull/12077">https://github.com/scipy/scipy/pull/12077</a>>`__: MAINT: malloc return value checks for cython<br>* `#12080 <<a href="https://github.com/scipy/scipy/pull/12080">https://github.com/scipy/scipy/pull/12080</a>>`__: MAINT: Remove suppress_warnings<br>* `#12085 <<a href="https://github.com/scipy/scipy/pull/12085">https://github.com/scipy/scipy/pull/12085</a>>`__: ENH: special: support ILP64 Lapack<br>* `#12086 <<a href="https://github.com/scipy/scipy/pull/12086">https://github.com/scipy/scipy/pull/12086</a>>`__: MAINT: Cleanup PyMODINIT_FUNC used during 2to3<br>* `#12097 <<a href="https://github.com/scipy/scipy/pull/12097">https://github.com/scipy/scipy/pull/12097</a>>`__: ENH: stats: override stats.rayleigh.fit with analytical MLE<br>* `#12112 <<a href="https://github.com/scipy/scipy/pull/12112">https://github.com/scipy/scipy/pull/12112</a>>`__: DOC: Improve integrate.nquad docstring<br>* `#12125 <<a href="https://github.com/scipy/scipy/pull/12125">https://github.com/scipy/scipy/pull/12125</a>>`__: TST: Add a test for stats.gmean with negative input<br>* `#12139 <<a href="https://github.com/scipy/scipy/pull/12139">https://github.com/scipy/scipy/pull/12139</a>>`__: TST: Reduce flakiness in lsmr test<br>* `#12142 <<a href="https://github.com/scipy/scipy/pull/12142">https://github.com/scipy/scipy/pull/12142</a>>`__: DOC: add a note in poisson distribution when mu=0 and k=0 in...<br>* `#12144 <<a href="https://github.com/scipy/scipy/pull/12144">https://github.com/scipy/scipy/pull/12144</a>>`__: DOC: Update ndimage.morphology.distance_transform\*<br>* `#12154 <<a href="https://github.com/scipy/scipy/pull/12154">https://github.com/scipy/scipy/pull/12154</a>>`__: ENH: scipy.signal: allow lists in gauss_spline<br>* `#12170 <<a href="https://github.com/scipy/scipy/pull/12170">https://github.com/scipy/scipy/pull/12170</a>>`__: ENH: scipy.stats: add negative hypergeometric distribution<br>* `#12177 <<a href="https://github.com/scipy/scipy/pull/12177">https://github.com/scipy/scipy/pull/12177</a>>`__: MAINT: Correctly add input line to ValueError<br>* `#12183 <<a href="https://github.com/scipy/scipy/pull/12183">https://github.com/scipy/scipy/pull/12183</a>>`__: ENH: Use fromfile where possible<br>* `#12186 <<a href="https://github.com/scipy/scipy/pull/12186">https://github.com/scipy/scipy/pull/12186</a>>`__: MAINT: generalize tests in SphericalVoronoi<br>* `#12198 <<a href="https://github.com/scipy/scipy/pull/12198">https://github.com/scipy/scipy/pull/12198</a>>`__: TST: Fix str + bytes error<br>* `#12199 <<a href="https://github.com/scipy/scipy/pull/12199">https://github.com/scipy/scipy/pull/12199</a>>`__: ENH: match np.result_type behaviour in some scipy.signal functions<br>* `#12200 <<a href="https://github.com/scipy/scipy/pull/12200">https://github.com/scipy/scipy/pull/12200</a>>`__: ENH: add FIR and IIR gammatone filters to scipy.signal<br>* `#12204 <<a href="https://github.com/scipy/scipy/pull/12204">https://github.com/scipy/scipy/pull/12204</a>>`__: ENH: Add overwrite argument for odr.ODR() and its test.<br>* `#12206 <<a href="https://github.com/scipy/scipy/pull/12206">https://github.com/scipy/scipy/pull/12206</a>>`__: MAINT:lstsq: Switch to tranposed problem if the array is tall<br>* `#12208 <<a href="https://github.com/scipy/scipy/pull/12208">https://github.com/scipy/scipy/pull/12208</a>>`__: wavfile bugfixes and maintenance<br>* `#12214 <<a href="https://github.com/scipy/scipy/pull/12214">https://github.com/scipy/scipy/pull/12214</a>>`__: DOC: fix docstring of "sd_beta" of odr.Output.<br>* `#12234 <<a href="https://github.com/scipy/scipy/pull/12234">https://github.com/scipy/scipy/pull/12234</a>>`__: MAINT: prevent divide by zero warnings in scipy.optimize BFGS...<br>* `#12235 <<a href="https://github.com/scipy/scipy/pull/12235">https://github.com/scipy/scipy/pull/12235</a>>`__: REL: set version to 1.6.0.dev0<br>* `#12237 <<a href="https://github.com/scipy/scipy/pull/12237">https://github.com/scipy/scipy/pull/12237</a>>`__: BUG: Fix exit condition for QUICK_SELECT pivot<br>* `#12242 <<a href="https://github.com/scipy/scipy/pull/12242">https://github.com/scipy/scipy/pull/12242</a>>`__: ENH: Rename ndimage.sum to ndimage.sum_labels (keep sum as alias)<br>* `#12243 <<a href="https://github.com/scipy/scipy/pull/12243">https://github.com/scipy/scipy/pull/12243</a>>`__: EHN: Update SuperLU<br>* `#12244 <<a href="https://github.com/scipy/scipy/pull/12244">https://github.com/scipy/scipy/pull/12244</a>>`__: MAINT: stats: avoid spurious warnings in ncx2.pdf<br>* `#12245 <<a href="https://github.com/scipy/scipy/pull/12245">https://github.com/scipy/scipy/pull/12245</a>>`__: DOC: Fixed incorrect default for mode in scipy.ndimage.spline_filter1d<br>* `#12248 <<a href="https://github.com/scipy/scipy/pull/12248">https://github.com/scipy/scipy/pull/12248</a>>`__: MAINT: clean up pavement.py<br>* `#12250 <<a href="https://github.com/scipy/scipy/pull/12250">https://github.com/scipy/scipy/pull/12250</a>>`__: ENH: Replaced csr_matrix() by tocsr() and complemented docstring<br>* `#12253 <<a href="https://github.com/scipy/scipy/pull/12253">https://github.com/scipy/scipy/pull/12253</a>>`__: TST, CI: turn on codecov patch diffs<br>* `#12259 <<a href="https://github.com/scipy/scipy/pull/12259">https://github.com/scipy/scipy/pull/12259</a>>`__: MAINT: Remove duplicated test for import cycles<br>* `#12263 <<a href="https://github.com/scipy/scipy/pull/12263">https://github.com/scipy/scipy/pull/12263</a>>`__: ENH: Rename LocalSearchWrapper bounds<br>* `#12265 <<a href="https://github.com/scipy/scipy/pull/12265">https://github.com/scipy/scipy/pull/12265</a>>`__: BUG optimize: Accept np.matrix in lsq_linear<br>* `#12266 <<a href="https://github.com/scipy/scipy/pull/12266">https://github.com/scipy/scipy/pull/12266</a>>`__: BUG: Fix paren error in dual annealing accept_reject calculation<br>* `#12269 <<a href="https://github.com/scipy/scipy/pull/12269">https://github.com/scipy/scipy/pull/12269</a>>`__: MAINT: Included mismatched shapes in error messages.<br>* `#12279 <<a href="https://github.com/scipy/scipy/pull/12279">https://github.com/scipy/scipy/pull/12279</a>>`__: MAINT: \`__array__\` and array protocols cannot be used in sparse.<br>* `#12281 <<a href="https://github.com/scipy/scipy/pull/12281">https://github.com/scipy/scipy/pull/12281</a>>`__: DOC: update wheel DL docs<br>* `#12283 <<a href="https://github.com/scipy/scipy/pull/12283">https://github.com/scipy/scipy/pull/12283</a>>`__: ENH: odr: ILP64 Blas support in ODR<br>* `#12284 <<a href="https://github.com/scipy/scipy/pull/12284">https://github.com/scipy/scipy/pull/12284</a>>`__: ENH: linalg: support for ILP64 BLAS/LAPACK in f2py wrappers<br>* `#12286 <<a href="https://github.com/scipy/scipy/pull/12286">https://github.com/scipy/scipy/pull/12286</a>>`__: ENH: Cythonize scipy.spatial.transform.Rotation<br>* `#12287 <<a href="https://github.com/scipy/scipy/pull/12287">https://github.com/scipy/scipy/pull/12287</a>>`__: ENH: Read arbitrary bit depth (including 24-bit) WAVs<br>* `#12292 <<a href="https://github.com/scipy/scipy/pull/12292">https://github.com/scipy/scipy/pull/12292</a>>`__: BLD: fix musl compilation<br>* `#12293 <<a href="https://github.com/scipy/scipy/pull/12293">https://github.com/scipy/scipy/pull/12293</a>>`__: MAINT: Fix a DeprecationWarning in validate_runtests_log.py.<br>* `#12296 <<a href="https://github.com/scipy/scipy/pull/12296">https://github.com/scipy/scipy/pull/12296</a>>`__: DOC: Clarify area/volume in scipy.spatial.ConvexHull docstrings<br>* `#12302 <<a href="https://github.com/scipy/scipy/pull/12302">https://github.com/scipy/scipy/pull/12302</a>>`__: CI: Run travis builds on master to keep cache up to date<br>* `#12305 <<a href="https://github.com/scipy/scipy/pull/12305">https://github.com/scipy/scipy/pull/12305</a>>`__: TST: Cleanup print statements in tests<br>* `#12323 <<a href="https://github.com/scipy/scipy/pull/12323">https://github.com/scipy/scipy/pull/12323</a>>`__: ENH: Add a Bunch-like class to use as a backwards compatible...<br>* `#12324 <<a href="https://github.com/scipy/scipy/pull/12324">https://github.com/scipy/scipy/pull/12324</a>>`__: BUG: io: Fix an error that occurs when attempting to raise a...<br>* `#12327 <<a href="https://github.com/scipy/scipy/pull/12327">https://github.com/scipy/scipy/pull/12327</a>>`__: DOC: clarify docstrings of \`query_ball_tree\` and \`query_pairs\`<br>* `#12334 <<a href="https://github.com/scipy/scipy/pull/12334">https://github.com/scipy/scipy/pull/12334</a>>`__: PERF: Improve cKDTree.query_ball_point constant time cython overhead<br>* `#12338 <<a href="https://github.com/scipy/scipy/pull/12338">https://github.com/scipy/scipy/pull/12338</a>>`__: DOC: improve consistency and clarity of docs in linalg and sparse/linalg<br>* `#12341 <<a href="https://github.com/scipy/scipy/pull/12341">https://github.com/scipy/scipy/pull/12341</a>>`__: DOC: add Examples for KDTree query_ball_tree and query_pairs<br>* `#12343 <<a href="https://github.com/scipy/scipy/pull/12343">https://github.com/scipy/scipy/pull/12343</a>>`__: DOC: add examples for special.eval_legendre()<br>* `#12349 <<a href="https://github.com/scipy/scipy/pull/12349">https://github.com/scipy/scipy/pull/12349</a>>`__: BUG: avoid overflow in sum() for 32-bit systems<br>* `#12351 <<a href="https://github.com/scipy/scipy/pull/12351">https://github.com/scipy/scipy/pull/12351</a>>`__: DOC: Fix example wavfile to be 16bit<br>* `#12352 <<a href="https://github.com/scipy/scipy/pull/12352">https://github.com/scipy/scipy/pull/12352</a>>`__: [BUG] Consider 0/0 division in DOP853 error estimation<br>* `#12353 <<a href="https://github.com/scipy/scipy/pull/12353">https://github.com/scipy/scipy/pull/12353</a>>`__: Fix exception causes in vq.py<br>* `#12354 <<a href="https://github.com/scipy/scipy/pull/12354">https://github.com/scipy/scipy/pull/12354</a>>`__: MAINT: Cleanup unneeded void\* cast in setlist.pxd<br>* `#12355 <<a href="https://github.com/scipy/scipy/pull/12355">https://github.com/scipy/scipy/pull/12355</a>>`__: TST: Remove hack for old win-amd64 bug<br>* `#12356 <<a href="https://github.com/scipy/scipy/pull/12356">https://github.com/scipy/scipy/pull/12356</a>>`__: ENH: Faster implementation of scipy.sparse.block_diag (#9411...<br>* `#12357 <<a href="https://github.com/scipy/scipy/pull/12357">https://github.com/scipy/scipy/pull/12357</a>>`__: MAINT,TST: update and run scipy/special/utils/convert.py<br>* `#12358 <<a href="https://github.com/scipy/scipy/pull/12358">https://github.com/scipy/scipy/pull/12358</a>>`__: TST: Check mstat.skewtest pvalue<br>* `#12359 <<a href="https://github.com/scipy/scipy/pull/12359">https://github.com/scipy/scipy/pull/12359</a>>`__: TST: Sparse matrix test with int64 indptr and indices<br>* `#12363 <<a href="https://github.com/scipy/scipy/pull/12363">https://github.com/scipy/scipy/pull/12363</a>>`__: DOC: ref. in CloughTocher2DInterpolator<br>* `#12364 <<a href="https://github.com/scipy/scipy/pull/12364">https://github.com/scipy/scipy/pull/12364</a>>`__: DOC: \`sparse_distance_matrix\` and \`count_neighbors\` examples<br>* `#12371 <<a href="https://github.com/scipy/scipy/pull/12371">https://github.com/scipy/scipy/pull/12371</a>>`__: MAINT, CI: bump to latest stable OpenBLAS<br>* `#12372 <<a href="https://github.com/scipy/scipy/pull/12372">https://github.com/scipy/scipy/pull/12372</a>>`__: MAINT: Minor cleanup of (c)KDTree tests<br>* `#12374 <<a href="https://github.com/scipy/scipy/pull/12374">https://github.com/scipy/scipy/pull/12374</a>>`__: DEP: Deprecate \`distance.wminkowski\`<br>* `#12375 <<a href="https://github.com/scipy/scipy/pull/12375">https://github.com/scipy/scipy/pull/12375</a>>`__: ENH: Add fast path for minkowski distance with p=1,2 and support...<br>* `#12376 <<a href="https://github.com/scipy/scipy/pull/12376">https://github.com/scipy/scipy/pull/12376</a>>`__: Fix exception causes in most of the codebase<br>* `#12377 <<a href="https://github.com/scipy/scipy/pull/12377">https://github.com/scipy/scipy/pull/12377</a>>`__: DOC: Quick fix - adds newline to correlation_lags docstring Examples...<br>* `#12381 <<a href="https://github.com/scipy/scipy/pull/12381">https://github.com/scipy/scipy/pull/12381</a>>`__: BENCH: remove obsolete goal_time param<br>* `#12382 <<a href="https://github.com/scipy/scipy/pull/12382">https://github.com/scipy/scipy/pull/12382</a>>`__: ENH: Replace KDTree with a thin wrapper over cKDTree<br>* `#12385 <<a href="https://github.com/scipy/scipy/pull/12385">https://github.com/scipy/scipy/pull/12385</a>>`__: DOC: improve docstrings of interpolate.NearestNDInterpolator.__call__...<br>* `#12387 <<a href="https://github.com/scipy/scipy/pull/12387">https://github.com/scipy/scipy/pull/12387</a>>`__: DOC/STY: add example to scipy.signal.correlate<br>* `#12393 <<a href="https://github.com/scipy/scipy/pull/12393">https://github.com/scipy/scipy/pull/12393</a>>`__: CI: Replace the existing check for non-ASCII characters with...<br>* `#12394 <<a href="https://github.com/scipy/scipy/pull/12394">https://github.com/scipy/scipy/pull/12394</a>>`__: CI: arm64 numpy now available<br>* `#12395 <<a href="https://github.com/scipy/scipy/pull/12395">https://github.com/scipy/scipy/pull/12395</a>>`__: ENH: improve stats.binned_statistic_dd performance<br>* `#12396 <<a href="https://github.com/scipy/scipy/pull/12396">https://github.com/scipy/scipy/pull/12396</a>>`__: DOC, MAINT: forward port 1.5.0 relnotes<br>* `#12398 <<a href="https://github.com/scipy/scipy/pull/12398">https://github.com/scipy/scipy/pull/12398</a>>`__: API: Disable len() and indexing of Rotation instances with single...<br>* `#12399 <<a href="https://github.com/scipy/scipy/pull/12399">https://github.com/scipy/scipy/pull/12399</a>>`__: MAINT: Replace some Unicode dash-like chars with an ASCII hyphen.<br>* `#12402 <<a href="https://github.com/scipy/scipy/pull/12402">https://github.com/scipy/scipy/pull/12402</a>>`__: update .mailmap<br>* `#12404 <<a href="https://github.com/scipy/scipy/pull/12404">https://github.com/scipy/scipy/pull/12404</a>>`__: MAINT: io: Change the encoding comment of test_mio.py to utf-8.<br>* `#12416 <<a href="https://github.com/scipy/scipy/pull/12416">https://github.com/scipy/scipy/pull/12416</a>>`__: CI: cache mingw, azure pipelines<br>* `#12427 <<a href="https://github.com/scipy/scipy/pull/12427">https://github.com/scipy/scipy/pull/12427</a>>`__: BUG: logic error in loop unrolling (cKDTree)<br>* `#12432 <<a href="https://github.com/scipy/scipy/pull/12432">https://github.com/scipy/scipy/pull/12432</a>>`__: DOC: Remove the "Basic functions" section from the SciPy tutorial.<br>* `#12434 <<a href="https://github.com/scipy/scipy/pull/12434">https://github.com/scipy/scipy/pull/12434</a>>`__: ENH:linalg: Add LAPACK wrappers pptrf/pptrs/ppsv/pptri/ppcon<br>* `#12435 <<a href="https://github.com/scipy/scipy/pull/12435">https://github.com/scipy/scipy/pull/12435</a>>`__: DOC: fix simplex math for scipy.stats.dirichlet documentation<br>* `#12439 <<a href="https://github.com/scipy/scipy/pull/12439">https://github.com/scipy/scipy/pull/12439</a>>`__: DOC: add API methods summary for NdPPoly<br>* `#12443 <<a href="https://github.com/scipy/scipy/pull/12443">https://github.com/scipy/scipy/pull/12443</a>>`__: BUG: stats: Improve calculation of exponnorm.pdf<br>* `#12448 <<a href="https://github.com/scipy/scipy/pull/12448">https://github.com/scipy/scipy/pull/12448</a>>`__: DOC: stats: Add "Examples" to the ansari docstring.<br>* `#12450 <<a href="https://github.com/scipy/scipy/pull/12450">https://github.com/scipy/scipy/pull/12450</a>>`__: ENH: add \`leaves_color_list\` for cluster.dendrogram dictionary.<br>* `#12451 <<a href="https://github.com/scipy/scipy/pull/12451">https://github.com/scipy/scipy/pull/12451</a>>`__: MAINT: remove "blacklist" terminology from code base<br>* `#12452 <<a href="https://github.com/scipy/scipy/pull/12452">https://github.com/scipy/scipy/pull/12452</a>>`__: DOC: clarify the meaning of whitening for cluster.vq.whiten()<br>* `#12455 <<a href="https://github.com/scipy/scipy/pull/12455">https://github.com/scipy/scipy/pull/12455</a>>`__: MAINT: clearer error message in setup.py<br>* `#12457 <<a href="https://github.com/scipy/scipy/pull/12457">https://github.com/scipy/scipy/pull/12457</a>>`__: ENH: stats: override stats.pareto.fit with analytical MLE<br>* `#12460 <<a href="https://github.com/scipy/scipy/pull/12460">https://github.com/scipy/scipy/pull/12460</a>>`__: check if column in spearman rho is entirely NaN or Inf<br>* `#12463 <<a href="https://github.com/scipy/scipy/pull/12463">https://github.com/scipy/scipy/pull/12463</a>>`__: DOC: improve and clean up \*Spline docstrings in fitpack2.py<br>* `#12474 <<a href="https://github.com/scipy/scipy/pull/12474">https://github.com/scipy/scipy/pull/12474</a>>`__: ENH: linalg: speedup _sqrtm_triu by moving tight loop to Cython<br>* `#12476 <<a href="https://github.com/scipy/scipy/pull/12476">https://github.com/scipy/scipy/pull/12476</a>>`__: ENH: add IIR comb filter to scipy.signal<br>* `#12484 <<a href="https://github.com/scipy/scipy/pull/12484">https://github.com/scipy/scipy/pull/12484</a>>`__: Fix documentation for minimize<br>* `#12486 <<a href="https://github.com/scipy/scipy/pull/12486">https://github.com/scipy/scipy/pull/12486</a>>`__: DOC: add a note in poisson distribution when mu=0 and k=0 in...<br>* `#12491 <<a href="https://github.com/scipy/scipy/pull/12491">https://github.com/scipy/scipy/pull/12491</a>>`__: MAINT: forward port 1.5.1 release notes<br>* `#12508 <<a href="https://github.com/scipy/scipy/pull/12508">https://github.com/scipy/scipy/pull/12508</a>>`__: Fix exception causes all over the codebase<br>* `#12514 <<a href="https://github.com/scipy/scipy/pull/12514">https://github.com/scipy/scipy/pull/12514</a>>`__: ENH: stats: override stats.invgauss.fit with analytical MLE<br>* `#12519 <<a href="https://github.com/scipy/scipy/pull/12519">https://github.com/scipy/scipy/pull/12519</a>>`__: PERF: Avoid np.zeros when custom initialization is needed anyway<br>* `#12520 <<a href="https://github.com/scipy/scipy/pull/12520">https://github.com/scipy/scipy/pull/12520</a>>`__: DOC: Minor RST section renaming.<br>* `#12521 <<a href="https://github.com/scipy/scipy/pull/12521">https://github.com/scipy/scipy/pull/12521</a>>`__: MAINT: Remove unused imports<br>* `#12522 <<a href="https://github.com/scipy/scipy/pull/12522">https://github.com/scipy/scipy/pull/12522</a>>`__: PERF: Get rid of unnececssary allocation in VarReader5.cread_fieldnames<br>* `#12524 <<a href="https://github.com/scipy/scipy/pull/12524">https://github.com/scipy/scipy/pull/12524</a>>`__: DOC: special: Set Axes3D rect to avoid clipping labels in plot.<br>* `#12525 <<a href="https://github.com/scipy/scipy/pull/12525">https://github.com/scipy/scipy/pull/12525</a>>`__: Fix large sparse nnz<br>* `#12526 <<a href="https://github.com/scipy/scipy/pull/12526">https://github.com/scipy/scipy/pull/12526</a>>`__: DOC: Remove double section and too long header underline.<br>* `#12527 <<a href="https://github.com/scipy/scipy/pull/12527">https://github.com/scipy/scipy/pull/12527</a>>`__: Improve error message for wrong interpolation type<br>* `#12530 <<a href="https://github.com/scipy/scipy/pull/12530">https://github.com/scipy/scipy/pull/12530</a>>`__: Move redundant logic outside loop for conditional speedup in...<br>* `#12532 <<a href="https://github.com/scipy/scipy/pull/12532">https://github.com/scipy/scipy/pull/12532</a>>`__: ENH: Add norm={"forward", "backward"} to \`scipy.fft\`<br>* `#12535 <<a href="https://github.com/scipy/scipy/pull/12535">https://github.com/scipy/scipy/pull/12535</a>>`__: MAINT: Avoid sphinx deprecated aliases for SeeAlso and Only<br>* `#12540 <<a href="https://github.com/scipy/scipy/pull/12540">https://github.com/scipy/scipy/pull/12540</a>>`__: BUG: fix odr.output.work_ind key bug and add its test.<br>* `#12541 <<a href="https://github.com/scipy/scipy/pull/12541">https://github.com/scipy/scipy/pull/12541</a>>`__: ENH: add solver for minimum weight full bipartite matching<br>* `#12550 <<a href="https://github.com/scipy/scipy/pull/12550">https://github.com/scipy/scipy/pull/12550</a>>`__: PERF: pickling speed of rv\*<br>* `#12551 <<a href="https://github.com/scipy/scipy/pull/12551">https://github.com/scipy/scipy/pull/12551</a>>`__: DOC: fix typo in cluster/_hierarchy.pyx<br>* `#12552 <<a href="https://github.com/scipy/scipy/pull/12552">https://github.com/scipy/scipy/pull/12552</a>>`__: CI: Cleanup travis pip installs<br>* `#12556 <<a href="https://github.com/scipy/scipy/pull/12556">https://github.com/scipy/scipy/pull/12556</a>>`__: BUG: Fix problem with Scipy.integrate.solve_bvp for big problems<br>* `#12557 <<a href="https://github.com/scipy/scipy/pull/12557">https://github.com/scipy/scipy/pull/12557</a>>`__: MAINT: Use extern templates to improve sparsetools compile time<br>* `#12558 <<a href="https://github.com/scipy/scipy/pull/12558">https://github.com/scipy/scipy/pull/12558</a>>`__: MAINT: Remove hack to allow scipy.fft to act like a function<br>* `#12563 <<a href="https://github.com/scipy/scipy/pull/12563">https://github.com/scipy/scipy/pull/12563</a>>`__: MAINT: Remove unused mu0 in special/orthogonal.py<br>* `#12564 <<a href="https://github.com/scipy/scipy/pull/12564">https://github.com/scipy/scipy/pull/12564</a>>`__: DOC: fix return type docstring for least_squares<br>* `#12565 <<a href="https://github.com/scipy/scipy/pull/12565">https://github.com/scipy/scipy/pull/12565</a>>`__: DOC: stats: respond to query about Kruskal-Wallis test being...<br>* `#12566 <<a href="https://github.com/scipy/scipy/pull/12566">https://github.com/scipy/scipy/pull/12566</a>>`__: BUG: Interpolate: use stable sort<br>* `#12568 <<a href="https://github.com/scipy/scipy/pull/12568">https://github.com/scipy/scipy/pull/12568</a>>`__: Updated documentation for as_quat<br>* `#12571 <<a href="https://github.com/scipy/scipy/pull/12571">https://github.com/scipy/scipy/pull/12571</a>>`__: DEP: remove deprecated slepian window<br>* `#12573 <<a href="https://github.com/scipy/scipy/pull/12573">https://github.com/scipy/scipy/pull/12573</a>>`__: DEP: remove \`frechet_l\` and \`frechet_r\`<br>* `#12575 <<a href="https://github.com/scipy/scipy/pull/12575">https://github.com/scipy/scipy/pull/12575</a>>`__: BUG: stats: fix multinomial.pmf NaNs when params sum > 1<br>* `#12576 <<a href="https://github.com/scipy/scipy/pull/12576">https://github.com/scipy/scipy/pull/12576</a>>`__: MAINT: remove warning from LSQSphereBivariateSpline<br>* `#12582 <<a href="https://github.com/scipy/scipy/pull/12582">https://github.com/scipy/scipy/pull/12582</a>>`__: ENH: Multivariate t-distribution<br>* `#12587 <<a href="https://github.com/scipy/scipy/pull/12587">https://github.com/scipy/scipy/pull/12587</a>>`__: ENH: speed up rvs of gengamma in scipy.stats<br>* `#12588 <<a href="https://github.com/scipy/scipy/pull/12588">https://github.com/scipy/scipy/pull/12588</a>>`__: DOC: add Examples add see also sections for LinearNDInterpolator,...<br>* `#12597 <<a href="https://github.com/scipy/scipy/pull/12597">https://github.com/scipy/scipy/pull/12597</a>>`__: ENH: Add single-sided p-values to t-tests<br>* `#12599 <<a href="https://github.com/scipy/scipy/pull/12599">https://github.com/scipy/scipy/pull/12599</a>>`__: Small update to scipy FFT tutorial<br>* `#12600 <<a href="https://github.com/scipy/scipy/pull/12600">https://github.com/scipy/scipy/pull/12600</a>>`__: ENH: disjoint set data structure<br>* `#12602 <<a href="https://github.com/scipy/scipy/pull/12602">https://github.com/scipy/scipy/pull/12602</a>>`__: BUG: add const for Read-only views in interpnd.pyx<br>* `#12605 <<a href="https://github.com/scipy/scipy/pull/12605">https://github.com/scipy/scipy/pull/12605</a>>`__: BUG: correct \`np.asanyarray\` use in \`scipy.constants.lambda2nu\`<br>* `#12610 <<a href="https://github.com/scipy/scipy/pull/12610">https://github.com/scipy/scipy/pull/12610</a>>`__: MAINT: forward port 1.5.2 release notes<br>* `#12612 <<a href="https://github.com/scipy/scipy/pull/12612">https://github.com/scipy/scipy/pull/12612</a>>`__: MAINT: stats: Use explicit keyword parameters instead of \`\*\*kwds\`.<br>* `#12616 <<a href="https://github.com/scipy/scipy/pull/12616">https://github.com/scipy/scipy/pull/12616</a>>`__: DOC: make explicit docstring that interpolate.interp1d only accepts...<br>* `#12618 <<a href="https://github.com/scipy/scipy/pull/12618">https://github.com/scipy/scipy/pull/12618</a>>`__: DOC: Minor doc formatting.<br>* `#12640 <<a href="https://github.com/scipy/scipy/pull/12640">https://github.com/scipy/scipy/pull/12640</a>>`__: MAINT: stats: fix issues with scipy.stats.pearson3 docs, moment,...<br>* `#12647 <<a href="https://github.com/scipy/scipy/pull/12647">https://github.com/scipy/scipy/pull/12647</a>>`__: TST: Add Boost ellipr[cdfgj]_data test data<br>* `#12648 <<a href="https://github.com/scipy/scipy/pull/12648">https://github.com/scipy/scipy/pull/12648</a>>`__: DOC: Update special/utils/README with instructions<br>* `#12649 <<a href="https://github.com/scipy/scipy/pull/12649">https://github.com/scipy/scipy/pull/12649</a>>`__: DOC: simplified pip quickstart guide<br>* `#12650 <<a href="https://github.com/scipy/scipy/pull/12650">https://github.com/scipy/scipy/pull/12650</a>>`__: DOC: stats: Fix boxcox docstring: lambda can be negative.<br>* `#12655 <<a href="https://github.com/scipy/scipy/pull/12655">https://github.com/scipy/scipy/pull/12655</a>>`__: DOC: update Steering Council members listed in governance docs<br>* `#12659 <<a href="https://github.com/scipy/scipy/pull/12659">https://github.com/scipy/scipy/pull/12659</a>>`__: rv_sample expect bug<br>* `#12663 <<a href="https://github.com/scipy/scipy/pull/12663">https://github.com/scipy/scipy/pull/12663</a>>`__: DOC: optimize: try to fix linprog method-specific documentation<br>* `#12664 <<a href="https://github.com/scipy/scipy/pull/12664">https://github.com/scipy/scipy/pull/12664</a>>`__: BUG: stats: Fix logpdf with large negative values for logistic...<br>* `#12666 <<a href="https://github.com/scipy/scipy/pull/12666">https://github.com/scipy/scipy/pull/12666</a>>`__: MAINT: Fixes from static analysis<br>* `#12667 <<a href="https://github.com/scipy/scipy/pull/12667">https://github.com/scipy/scipy/pull/12667</a>>`__: ENH: Adding Modified Rodrigues Parameters to the Rotation class<br>* `#12670 <<a href="https://github.com/scipy/scipy/pull/12670">https://github.com/scipy/scipy/pull/12670</a>>`__: DOC: Update documentation for Gamma distribution<br>* `#12673 <<a href="https://github.com/scipy/scipy/pull/12673">https://github.com/scipy/scipy/pull/12673</a>>`__: API: Unconditionally return np.intp from cKDTree.query<br>* `#12677 <<a href="https://github.com/scipy/scipy/pull/12677">https://github.com/scipy/scipy/pull/12677</a>>`__: MAINT: Add Autogenerated notice to ufuncs.pyi<br>* `#12682 <<a href="https://github.com/scipy/scipy/pull/12682">https://github.com/scipy/scipy/pull/12682</a>>`__: MAINT: Remove _util._valarray<br>* `#12688 <<a href="https://github.com/scipy/scipy/pull/12688">https://github.com/scipy/scipy/pull/12688</a>>`__: MAINT: add f2py-generated scipy.integrate files to .gitignore<br>* `#12689 <<a href="https://github.com/scipy/scipy/pull/12689">https://github.com/scipy/scipy/pull/12689</a>>`__: BENCH: simplify benchmark setup, remove benchmarks/run.py<br>* `#12694 <<a href="https://github.com/scipy/scipy/pull/12694">https://github.com/scipy/scipy/pull/12694</a>>`__: scipy/stats: Add laplace_asymmetric continuous distribution<br>* `#12695 <<a href="https://github.com/scipy/scipy/pull/12695">https://github.com/scipy/scipy/pull/12695</a>>`__: DOC: update Ubuntu quickstart; conda compilers now work!<br>* `#12698 <<a href="https://github.com/scipy/scipy/pull/12698">https://github.com/scipy/scipy/pull/12698</a>>`__: MAINT: Replace np.max with np.maximum<br>* `#12700 <<a href="https://github.com/scipy/scipy/pull/12700">https://github.com/scipy/scipy/pull/12700</a>>`__: TST: bump test precision for constrained trustregion test<br>* `#12702 <<a href="https://github.com/scipy/scipy/pull/12702">https://github.com/scipy/scipy/pull/12702</a>>`__: TST: bump test tolerance for \`DifferentialEvolutionSolver.test_L4\`<br>* `#12703 <<a href="https://github.com/scipy/scipy/pull/12703">https://github.com/scipy/scipy/pull/12703</a>>`__: BUG: Improve input validation for sepfir2d<br>* `#12708 <<a href="https://github.com/scipy/scipy/pull/12708">https://github.com/scipy/scipy/pull/12708</a>>`__: MAINT: fix a typo in scipy.sparse<br>* `#12709 <<a href="https://github.com/scipy/scipy/pull/12709">https://github.com/scipy/scipy/pull/12709</a>>`__: BUG: bvls can fail catastrophically to converge<br>* `#12711 <<a href="https://github.com/scipy/scipy/pull/12711">https://github.com/scipy/scipy/pull/12711</a>>`__: MAINT: Use platform.python_implementation to determine IS_PYPY<br>* `#12713 <<a href="https://github.com/scipy/scipy/pull/12713">https://github.com/scipy/scipy/pull/12713</a>>`__: TST: Fix flaky test_lgmres<br>* `#12716 <<a href="https://github.com/scipy/scipy/pull/12716">https://github.com/scipy/scipy/pull/12716</a>>`__: DOC: add examples and tutorial links for interpolate functions...<br>* `#12717 <<a href="https://github.com/scipy/scipy/pull/12717">https://github.com/scipy/scipy/pull/12717</a>>`__: DOC: Fix Issue #5396<br>* `#12725 <<a href="https://github.com/scipy/scipy/pull/12725">https://github.com/scipy/scipy/pull/12725</a>>`__: ENH: Support complex-valued images and kernels for many ndimage...<br>* `#12729 <<a href="https://github.com/scipy/scipy/pull/12729">https://github.com/scipy/scipy/pull/12729</a>>`__: DEP: remove setup_requires<br>* `#12732 <<a href="https://github.com/scipy/scipy/pull/12732">https://github.com/scipy/scipy/pull/12732</a>>`__: BENCH: skip benchmarks instead of hiding them when SCIPY_XSLOW=0<br>* `#12734 <<a href="https://github.com/scipy/scipy/pull/12734">https://github.com/scipy/scipy/pull/12734</a>>`__: CI: Don't ignore line-length in the lint_diff check.<br>* `#12736 <<a href="https://github.com/scipy/scipy/pull/12736">https://github.com/scipy/scipy/pull/12736</a>>`__: DOC: Fix signal.windows.get_window() 'exponential' docstring<br>* `#12737 <<a href="https://github.com/scipy/scipy/pull/12737">https://github.com/scipy/scipy/pull/12737</a>>`__: ENH: stats: override stats.gumbel_r.fit and stats.gumbel_l.fit...<br>* `#12738 <<a href="https://github.com/scipy/scipy/pull/12738">https://github.com/scipy/scipy/pull/12738</a>>`__: ENH: stats: override stats.logistic.fit with system of equations...<br>* `#12743 <<a href="https://github.com/scipy/scipy/pull/12743">https://github.com/scipy/scipy/pull/12743</a>>`__: BUG: Avoid negative variances in circular statistics<br>* `#12744 <<a href="https://github.com/scipy/scipy/pull/12744">https://github.com/scipy/scipy/pull/12744</a>>`__: Prevent build error on GNU/Hurd<br>* `#12746 <<a href="https://github.com/scipy/scipy/pull/12746">https://github.com/scipy/scipy/pull/12746</a>>`__: TST: parameterize the test cases in test_ndimage.py<br>* `#12752 <<a href="https://github.com/scipy/scipy/pull/12752">https://github.com/scipy/scipy/pull/12752</a>>`__: DOC: Add examples for some root finding functions.<br>* `#12754 <<a href="https://github.com/scipy/scipy/pull/12754">https://github.com/scipy/scipy/pull/12754</a>>`__: MAINT, CI: Azure windows deps multiline<br>* `#12756 <<a href="https://github.com/scipy/scipy/pull/12756">https://github.com/scipy/scipy/pull/12756</a>>`__: ENH: stats: Add an sf method to levy for improved precision in...<br>* `#12757 <<a href="https://github.com/scipy/scipy/pull/12757">https://github.com/scipy/scipy/pull/12757</a>>`__: ENH: stats: Add an sf method to levy_l for improved precision.<br>* `#12765 <<a href="https://github.com/scipy/scipy/pull/12765">https://github.com/scipy/scipy/pull/12765</a>>`__: TST, MAINT: infeasible_2 context<br>* `#12767 <<a href="https://github.com/scipy/scipy/pull/12767">https://github.com/scipy/scipy/pull/12767</a>>`__: Fix spline interpolation boundary handling for modes reflect...<br>* `#12769 <<a href="https://github.com/scipy/scipy/pull/12769">https://github.com/scipy/scipy/pull/12769</a>>`__: DOC: syntax error in scipy.interpolate.bspl<br>* `#12770 <<a href="https://github.com/scipy/scipy/pull/12770">https://github.com/scipy/scipy/pull/12770</a>>`__: ENH: add nearest-up rounding to scipy.interpolate.interp1d<br>* `#12771 <<a href="https://github.com/scipy/scipy/pull/12771">https://github.com/scipy/scipy/pull/12771</a>>`__: TST: fix invalid input unit test for scipy.signal.gammatone<br>* `#12775 <<a href="https://github.com/scipy/scipy/pull/12775">https://github.com/scipy/scipy/pull/12775</a>>`__: ENH: Adds quadratic_assignment with two methods<br>* `#12776 <<a href="https://github.com/scipy/scipy/pull/12776">https://github.com/scipy/scipy/pull/12776</a>>`__: ENH: add grid-constant boundary handling in ndimage interpolation...<br>* `#12777 <<a href="https://github.com/scipy/scipy/pull/12777">https://github.com/scipy/scipy/pull/12777</a>>`__: Add Taylor Window function - Common in Radar DSP<br>* `#12779 <<a href="https://github.com/scipy/scipy/pull/12779">https://github.com/scipy/scipy/pull/12779</a>>`__: ENH: Improvements to pocketfft thread pool and ARM neon vectorization<br>* `#12788 <<a href="https://github.com/scipy/scipy/pull/12788">https://github.com/scipy/scipy/pull/12788</a>>`__: API: Rename cKDTree n_jobs argument to workers<br>* `#12792 <<a href="https://github.com/scipy/scipy/pull/12792">https://github.com/scipy/scipy/pull/12792</a>>`__: DOC: remove THANKS.txt file in favor of <a href="http://scipy.org">scipy.org</a><br>* `#12793 <<a href="https://github.com/scipy/scipy/pull/12793">https://github.com/scipy/scipy/pull/12793</a>>`__: Add new flag to authors tool<br>* `#12802 <<a href="https://github.com/scipy/scipy/pull/12802">https://github.com/scipy/scipy/pull/12802</a>>`__: BENCH: add scipy.ndimage.interpolation benchmarks<br>* `#12803 <<a href="https://github.com/scipy/scipy/pull/12803">https://github.com/scipy/scipy/pull/12803</a>>`__: Do not pin the version of numpy in unsupported python versions<br>* `#12810 <<a href="https://github.com/scipy/scipy/pull/12810">https://github.com/scipy/scipy/pull/12810</a>>`__: CI: fix 32-bit Linux build failure on Azure CI runs<br>* `#12812 <<a href="https://github.com/scipy/scipy/pull/12812">https://github.com/scipy/scipy/pull/12812</a>>`__: ENH: support interpolation of complex-valued images<br>* `#12814 <<a href="https://github.com/scipy/scipy/pull/12814">https://github.com/scipy/scipy/pull/12814</a>>`__: BUG: nonlin_solve shouldn't pass non-vector dx to tol_norm<br>* `#12818 <<a href="https://github.com/scipy/scipy/pull/12818">https://github.com/scipy/scipy/pull/12818</a>>`__: Update ckdtree.pyx<br>* `#12822 <<a href="https://github.com/scipy/scipy/pull/12822">https://github.com/scipy/scipy/pull/12822</a>>`__: MAINT: simplify directed_hausdorff<br>* `#12827 <<a href="https://github.com/scipy/scipy/pull/12827">https://github.com/scipy/scipy/pull/12827</a>>`__: DOC: Fix wrong name w being used instead of worN in docs.<br>* `#12831 <<a href="https://github.com/scipy/scipy/pull/12831">https://github.com/scipy/scipy/pull/12831</a>>`__: DOC: fix typo in sparse/base.py<br>* `#12835 <<a href="https://github.com/scipy/scipy/pull/12835">https://github.com/scipy/scipy/pull/12835</a>>`__: MAINT: stats: Improve vonmises PDF calculation.<br>* `#12839 <<a href="https://github.com/scipy/scipy/pull/12839">https://github.com/scipy/scipy/pull/12839</a>>`__: ENH: scipy.stats: add multivariate hypergeometric distribution<br>* `#12843 <<a href="https://github.com/scipy/scipy/pull/12843">https://github.com/scipy/scipy/pull/12843</a>>`__: changed M to N in windows.dpss<br>* `#12846 <<a href="https://github.com/scipy/scipy/pull/12846">https://github.com/scipy/scipy/pull/12846</a>>`__: MAINT: update minimum NumPy version to 1.16.5<br>* `#12847 <<a href="https://github.com/scipy/scipy/pull/12847">https://github.com/scipy/scipy/pull/12847</a>>`__: DOC: Unify the formula in docs of scipy.stats.pearsonr()<br>* `#12849 <<a href="https://github.com/scipy/scipy/pull/12849">https://github.com/scipy/scipy/pull/12849</a>>`__: DOC: polish QAP docs for consistency and readability<br>* `#12852 <<a href="https://github.com/scipy/scipy/pull/12852">https://github.com/scipy/scipy/pull/12852</a>>`__: ENH, MAINT: Bring KDTree interface to feature-parity with cKDTree<br>* `#12858 <<a href="https://github.com/scipy/scipy/pull/12858">https://github.com/scipy/scipy/pull/12858</a>>`__: DOC: use :doi: and :arxiv: directives for references<br>* `#12872 <<a href="https://github.com/scipy/scipy/pull/12872">https://github.com/scipy/scipy/pull/12872</a>>`__: lazily import multiprocessing.Pool in MapWrapper<br>* `#12878 <<a href="https://github.com/scipy/scipy/pull/12878">https://github.com/scipy/scipy/pull/12878</a>>`__: DOC: document ScalarFunction<br>* `#12882 <<a href="https://github.com/scipy/scipy/pull/12882">https://github.com/scipy/scipy/pull/12882</a>>`__: MAINT: stats: Change a test to use <= instead of strictly less...<br>* `#12885 <<a href="https://github.com/scipy/scipy/pull/12885">https://github.com/scipy/scipy/pull/12885</a>>`__: numpy.linspace calls edited to ensure correct spacing.<br>* `#12886 <<a href="https://github.com/scipy/scipy/pull/12886">https://github.com/scipy/scipy/pull/12886</a>>`__: DOC: stats: Add 'versionadded' to cramervonmises docstring.<br>* `#12899 <<a href="https://github.com/scipy/scipy/pull/12899">https://github.com/scipy/scipy/pull/12899</a>>`__: TST: make a couple of tests expected to fail on 32-bit architectures<br>* `#12903 <<a href="https://github.com/scipy/scipy/pull/12903">https://github.com/scipy/scipy/pull/12903</a>>`__: DOC: update Windows build guide and move into contributor guide<br>* `#12907 <<a href="https://github.com/scipy/scipy/pull/12907">https://github.com/scipy/scipy/pull/12907</a>>`__: DOC: clarify which array the precenter option applies to<br>* `#12908 <<a href="https://github.com/scipy/scipy/pull/12908">https://github.com/scipy/scipy/pull/12908</a>>`__: MAINT: spatial: Remove two occurrences of unused variables in...<br>* `#12909 <<a href="https://github.com/scipy/scipy/pull/12909">https://github.com/scipy/scipy/pull/12909</a>>`__: ENH: stats: Add methods gumbel_r._sf and gumbel_r._isf<br>* `#12910 <<a href="https://github.com/scipy/scipy/pull/12910">https://github.com/scipy/scipy/pull/12910</a>>`__: CI: travis: Remove some unnecessary code from .travis.yml.<br>* `#12911 <<a href="https://github.com/scipy/scipy/pull/12911">https://github.com/scipy/scipy/pull/12911</a>>`__: Minor fixes to dendrogram plotting<br>* `#12921 <<a href="https://github.com/scipy/scipy/pull/12921">https://github.com/scipy/scipy/pull/12921</a>>`__: CI: don't run GitHub Actions on fork or in cron job<br>* `#12927 <<a href="https://github.com/scipy/scipy/pull/12927">https://github.com/scipy/scipy/pull/12927</a>>`__: MAINT: rename integrate.simps to simpson<br>* `#12934 <<a href="https://github.com/scipy/scipy/pull/12934">https://github.com/scipy/scipy/pull/12934</a>>`__: MAINT: rename trapz and cumtrapz to (cumulative\_)trapezoid<br>* `#12936 <<a href="https://github.com/scipy/scipy/pull/12936">https://github.com/scipy/scipy/pull/12936</a>>`__: MAINT: fix numerical precision in nct.stats<br>* `#12938 <<a href="https://github.com/scipy/scipy/pull/12938">https://github.com/scipy/scipy/pull/12938</a>>`__: MAINT: fix linter on master<br>* `#12941 <<a href="https://github.com/scipy/scipy/pull/12941">https://github.com/scipy/scipy/pull/12941</a>>`__: Update minimum AIX pinnings to match non AIX builds<br>* `#12955 <<a href="https://github.com/scipy/scipy/pull/12955">https://github.com/scipy/scipy/pull/12955</a>>`__: BUG: Fixed wrong NaNs check in scipy.stats.weightedtau<br>* `#12958 <<a href="https://github.com/scipy/scipy/pull/12958">https://github.com/scipy/scipy/pull/12958</a>>`__: ENH: stats: Implement _logpdf, _sf and _isf for nakagami.<br>* `#12962 <<a href="https://github.com/scipy/scipy/pull/12962">https://github.com/scipy/scipy/pull/12962</a>>`__: Correcting that p should be in [0,1] for a variety of discrete...<br>* `#12964 <<a href="https://github.com/scipy/scipy/pull/12964">https://github.com/scipy/scipy/pull/12964</a>>`__: BUG: added line.strip() to split_data_line()<br>* `#12968 <<a href="https://github.com/scipy/scipy/pull/12968">https://github.com/scipy/scipy/pull/12968</a>>`__: ENH: stats: Use only an analytical formula or scalar root-finding...<br>* `#12971 <<a href="https://github.com/scipy/scipy/pull/12971">https://github.com/scipy/scipy/pull/12971</a>>`__: MAINT: Declare support for Python 3.9<br>* `#12972 <<a href="https://github.com/scipy/scipy/pull/12972">https://github.com/scipy/scipy/pull/12972</a>>`__: MAINT: Remove redundant Python < 3.6 code<br>* `#12980 <<a href="https://github.com/scipy/scipy/pull/12980">https://github.com/scipy/scipy/pull/12980</a>>`__: DOC: Update documentation on optimize.rosen<br>* `#12983 <<a href="https://github.com/scipy/scipy/pull/12983">https://github.com/scipy/scipy/pull/12983</a>>`__: ENH: improvements to stats.linregress<br>* `#12990 <<a href="https://github.com/scipy/scipy/pull/12990">https://github.com/scipy/scipy/pull/12990</a>>`__: DOC: Clarify that using sos as output type for iirdesign can...<br>* `#12992 <<a href="https://github.com/scipy/scipy/pull/12992">https://github.com/scipy/scipy/pull/12992</a>>`__: DOC: capitalization and formatting in lsmr<br>* `#12995 <<a href="https://github.com/scipy/scipy/pull/12995">https://github.com/scipy/scipy/pull/12995</a>>`__: DOC: stats: Several documentation fixes.<br>* `#12996 <<a href="https://github.com/scipy/scipy/pull/12996">https://github.com/scipy/scipy/pull/12996</a>>`__: BUG: Improve error messages for \`range\` arg of binned_statistic_dd<br>* `#12998 <<a href="https://github.com/scipy/scipy/pull/12998">https://github.com/scipy/scipy/pull/12998</a>>`__: MAINT: approx_derivative with FP32 closes #12991<br>* `#13004 <<a href="https://github.com/scipy/scipy/pull/13004">https://github.com/scipy/scipy/pull/13004</a>>`__: TST: isinstance(OptimizeResult.message, str) closes #13001<br>* `#13006 <<a href="https://github.com/scipy/scipy/pull/13006">https://github.com/scipy/scipy/pull/13006</a>>`__: Keep correct dtype when loading empty mat arrays.<br>* `#13009 <<a href="https://github.com/scipy/scipy/pull/13009">https://github.com/scipy/scipy/pull/13009</a>>`__: MAINT: clip SLSQP step within bounds<br>* `#13012 <<a href="https://github.com/scipy/scipy/pull/13012">https://github.com/scipy/scipy/pull/13012</a>>`__: DOC: fix bilinear_zpk example labels<br>* `#13013 <<a href="https://github.com/scipy/scipy/pull/13013">https://github.com/scipy/scipy/pull/13013</a>>`__: ENH: Add \`subset\` and \`subsets\` methods to \`DisjointSet\`...<br>* `#13029 <<a href="https://github.com/scipy/scipy/pull/13029">https://github.com/scipy/scipy/pull/13029</a>>`__: MAINT: basinhopping callback for initial mininmisation<br>* `#13032 <<a href="https://github.com/scipy/scipy/pull/13032">https://github.com/scipy/scipy/pull/13032</a>>`__: DOC: fix docstring errors in in stats.wilcoxon<br>* `#13036 <<a href="https://github.com/scipy/scipy/pull/13036">https://github.com/scipy/scipy/pull/13036</a>>`__: BUG: forward port lint_diff shims<br>* `#13041 <<a href="https://github.com/scipy/scipy/pull/13041">https://github.com/scipy/scipy/pull/13041</a>>`__: MAINT: dogbox ensure x is within bounds closes #11403<br>* `#13042 <<a href="https://github.com/scipy/scipy/pull/13042">https://github.com/scipy/scipy/pull/13042</a>>`__: MAINT: forward port 1.5.4 release notes<br>* `#13046 <<a href="https://github.com/scipy/scipy/pull/13046">https://github.com/scipy/scipy/pull/13046</a>>`__: DOC: Update optimize.least_squares doc for all tolerance must...<br>* `#13052 <<a href="https://github.com/scipy/scipy/pull/13052">https://github.com/scipy/scipy/pull/13052</a>>`__: Typo fix for cluster documentation<br>* `#13054 <<a href="https://github.com/scipy/scipy/pull/13054">https://github.com/scipy/scipy/pull/13054</a>>`__: BUG: fix \`scipy.optimize.show_options\` for unknown methods....<br>* `#13056 <<a href="https://github.com/scipy/scipy/pull/13056">https://github.com/scipy/scipy/pull/13056</a>>`__: MAINT: fft: Fix a C++ compiler warning.<br>* `#13057 <<a href="https://github.com/scipy/scipy/pull/13057">https://github.com/scipy/scipy/pull/13057</a>>`__: Minor fixes on doc of function csr_tocsc<br>* `#13058 <<a href="https://github.com/scipy/scipy/pull/13058">https://github.com/scipy/scipy/pull/13058</a>>`__: DOC: stats: Replace np.float with np.float64 in a tutorial file.<br>* `#13059 <<a href="https://github.com/scipy/scipy/pull/13059">https://github.com/scipy/scipy/pull/13059</a>>`__: DOC: stats: Update the "Returns" section of the linregress docstring.<br>* `#13060 <<a href="https://github.com/scipy/scipy/pull/13060">https://github.com/scipy/scipy/pull/13060</a>>`__: MAINT: clip_x_for_func should be private<br>* `#13061 <<a href="https://github.com/scipy/scipy/pull/13061">https://github.com/scipy/scipy/pull/13061</a>>`__: DOC: signal.win -> signal.windows.win in Examples<br>* `#13063 <<a href="https://github.com/scipy/scipy/pull/13063">https://github.com/scipy/scipy/pull/13063</a>>`__: MAINT: Add suite-sparse and sksparse installation check<br>* `#13070 <<a href="https://github.com/scipy/scipy/pull/13070">https://github.com/scipy/scipy/pull/13070</a>>`__: MAINT: stats: Remove a couple obsolete comments.<br>* `#13073 <<a href="https://github.com/scipy/scipy/pull/13073">https://github.com/scipy/scipy/pull/13073</a>>`__: BUG: Fix scalar_search_wolfe2 to resolve #12157<br>* `#13078 <<a href="https://github.com/scipy/scipy/pull/13078">https://github.com/scipy/scipy/pull/13078</a>>`__: CI, MAINT: migrate Lint to Azure<br>* `#13081 <<a href="https://github.com/scipy/scipy/pull/13081">https://github.com/scipy/scipy/pull/13081</a>>`__: BLD: drop Python 3.6 support (NEP 29)<br>* `#13082 <<a href="https://github.com/scipy/scipy/pull/13082">https://github.com/scipy/scipy/pull/13082</a>>`__: MAINT: update minimum NumPy version to 1.16.5 in a couple more...<br>* `#13083 <<a href="https://github.com/scipy/scipy/pull/13083">https://github.com/scipy/scipy/pull/13083</a>>`__: DOC: update toolchain.rst<br>* `#13086 <<a href="https://github.com/scipy/scipy/pull/13086">https://github.com/scipy/scipy/pull/13086</a>>`__: DOC: Update the Parameters section of the correlation docstring<br>* `#13087 <<a href="https://github.com/scipy/scipy/pull/13087">https://github.com/scipy/scipy/pull/13087</a>>`__: ENH:signal: Speed-up Cython implementation of _sosfilt<br>* `#13089 <<a href="https://github.com/scipy/scipy/pull/13089">https://github.com/scipy/scipy/pull/13089</a>>`__: BLD, BUG: add c99 compiler flag to HiGHS basiclu library<br>* `#13091 <<a href="https://github.com/scipy/scipy/pull/13091">https://github.com/scipy/scipy/pull/13091</a>>`__: BUG: Fix GIL handling in _sosfilt<br>* `#13094 <<a href="https://github.com/scipy/scipy/pull/13094">https://github.com/scipy/scipy/pull/13094</a>>`__: DOC: clarify "location" in docstring of cKDTree.query<br>* `#13095 <<a href="https://github.com/scipy/scipy/pull/13095">https://github.com/scipy/scipy/pull/13095</a>>`__: Zoom resize update<br>* `#13097 <<a href="https://github.com/scipy/scipy/pull/13097">https://github.com/scipy/scipy/pull/13097</a>>`__: BUG: fix CubicSpline(..., bc_type="periodic") #11758<br>* `#13100 <<a href="https://github.com/scipy/scipy/pull/13100">https://github.com/scipy/scipy/pull/13100</a>>`__: BUG: sparse: Correct output format of kron<br>* `#13107 <<a href="https://github.com/scipy/scipy/pull/13107">https://github.com/scipy/scipy/pull/13107</a>>`__: ENH: faster linear_sum_assignment for small cost matrices<br>* `#13110 <<a href="https://github.com/scipy/scipy/pull/13110">https://github.com/scipy/scipy/pull/13110</a>>`__: CI, MAINT: refguide/asv checks to azure<br>* `#13112 <<a href="https://github.com/scipy/scipy/pull/13112">https://github.com/scipy/scipy/pull/13112</a>>`__: CI: fix MacOS CI<br>* `#13113 <<a href="https://github.com/scipy/scipy/pull/13113">https://github.com/scipy/scipy/pull/13113</a>>`__: CI: Install word list package for refguide-check<br>* `#13115 <<a href="https://github.com/scipy/scipy/pull/13115">https://github.com/scipy/scipy/pull/13115</a>>`__: BUG: add value range check for signal.iirdesign()<br>* `#13116 <<a href="https://github.com/scipy/scipy/pull/13116">https://github.com/scipy/scipy/pull/13116</a>>`__: CI: Don't report name errors after an exception in refguide-check<br>* `#13117 <<a href="https://github.com/scipy/scipy/pull/13117">https://github.com/scipy/scipy/pull/13117</a>>`__: CI: move sdist/pre-release test Azure<br>* `#13119 <<a href="https://github.com/scipy/scipy/pull/13119">https://github.com/scipy/scipy/pull/13119</a>>`__: Improve error message on friedmanchisquare function<br>* `#13121 <<a href="https://github.com/scipy/scipy/pull/13121">https://github.com/scipy/scipy/pull/13121</a>>`__: Fix factorial() for NaN on Python 3.10<br>* `#13123 <<a href="https://github.com/scipy/scipy/pull/13123">https://github.com/scipy/scipy/pull/13123</a>>`__: BLD: Specify file extension for language standard version tests<br>* `#13128 <<a href="https://github.com/scipy/scipy/pull/13128">https://github.com/scipy/scipy/pull/13128</a>>`__: TST: skip Fortran I/O test for ODR<br>* `#13130 <<a href="https://github.com/scipy/scipy/pull/13130">https://github.com/scipy/scipy/pull/13130</a>>`__: TST: skip factorial() float tests on Python 3.10<br>* `#13136 <<a href="https://github.com/scipy/scipy/pull/13136">https://github.com/scipy/scipy/pull/13136</a>>`__: CI:Add python dbg run to GH Actions<br>* `#13138 <<a href="https://github.com/scipy/scipy/pull/13138">https://github.com/scipy/scipy/pull/13138</a>>`__: CI: Port coverage, 64-bit BLAS, GCC 4.8 build to azure<br>* `#13139 <<a href="https://github.com/scipy/scipy/pull/13139">https://github.com/scipy/scipy/pull/13139</a>>`__: Fix edge case for mode='nearest' in ndimage.interpolation functions<br>* `#13141 <<a href="https://github.com/scipy/scipy/pull/13141">https://github.com/scipy/scipy/pull/13141</a>>`__: BUG: signal: Fix data type of the numerator returned by ss2tf.<br>* `#13144 <<a href="https://github.com/scipy/scipy/pull/13144">https://github.com/scipy/scipy/pull/13144</a>>`__: MAINT: stats: restrict gausshyper z > -1<br>* `#13146 <<a href="https://github.com/scipy/scipy/pull/13146">https://github.com/scipy/scipy/pull/13146</a>>`__: typo in csr.py<br>* `#13148 <<a href="https://github.com/scipy/scipy/pull/13148">https://github.com/scipy/scipy/pull/13148</a>>`__: BUG: stats: fix typo in stable rvs per gh-12870<br>* `#13149 <<a href="https://github.com/scipy/scipy/pull/13149">https://github.com/scipy/scipy/pull/13149</a>>`__: DOC: spatial/stats: cross-ref random rotation matrix functions<br>* `#13151 <<a href="https://github.com/scipy/scipy/pull/13151">https://github.com/scipy/scipy/pull/13151</a>>`__: MAINT: stats: Fix a test and a couple PEP-8 issues.<br>* `#13152 <<a href="https://github.com/scipy/scipy/pull/13152">https://github.com/scipy/scipy/pull/13152</a>>`__: MAINT: stats: Use np.take_along_axis in the private function...<br>* `#13154 <<a href="https://github.com/scipy/scipy/pull/13154">https://github.com/scipy/scipy/pull/13154</a>>`__: ENH: stats: Implement defined handling of constant inputs in...<br>* `#13156 <<a href="https://github.com/scipy/scipy/pull/13156">https://github.com/scipy/scipy/pull/13156</a>>`__: DOC: maintain equal display range for ndimage.zoom example<br>* `#13159 <<a href="https://github.com/scipy/scipy/pull/13159">https://github.com/scipy/scipy/pull/13159</a>>`__: CI: Azure: Don't run tests on merge commits, except for coverage<br>* `#13160 <<a href="https://github.com/scipy/scipy/pull/13160">https://github.com/scipy/scipy/pull/13160</a>>`__: DOC: stats: disambiguate location-shifted/noncentral<br>* `#13161 <<a href="https://github.com/scipy/scipy/pull/13161">https://github.com/scipy/scipy/pull/13161</a>>`__: BUG: DifferentialEvolutionSolver.__del__ can fail in garbage...<br>* `#13163 <<a href="https://github.com/scipy/scipy/pull/13163">https://github.com/scipy/scipy/pull/13163</a>>`__: BUG: stats: fix bug in spearmanr nan propagation<br>* `#13167 <<a href="https://github.com/scipy/scipy/pull/13167">https://github.com/scipy/scipy/pull/13167</a>>`__: MAINT: stats: Fix a test.<br>* `#13169 <<a href="https://github.com/scipy/scipy/pull/13169">https://github.com/scipy/scipy/pull/13169</a>>`__: BUG: stats: Fix handling of misaligned masks in mstats.pearsonr.<br>* `#13178 <<a href="https://github.com/scipy/scipy/pull/13178">https://github.com/scipy/scipy/pull/13178</a>>`__: CI: testing.yml --> macos.yml<br>* `#13181 <<a href="https://github.com/scipy/scipy/pull/13181">https://github.com/scipy/scipy/pull/13181</a>>`__: CI: fix lint<br>* `#13190 <<a href="https://github.com/scipy/scipy/pull/13190">https://github.com/scipy/scipy/pull/13190</a>>`__: BUG: optimize: fix a duplicate key bug for \`test_show_options\`<br>* `#13192 <<a href="https://github.com/scipy/scipy/pull/13192">https://github.com/scipy/scipy/pull/13192</a>>`__: BUG:linalg: Add overwrite option to gejsv wrapper<br>* `#13194 <<a href="https://github.com/scipy/scipy/pull/13194">https://github.com/scipy/scipy/pull/13194</a>>`__: BUG: slsqp should be able to use rel_step<br>* `#13199 <<a href="https://github.com/scipy/scipy/pull/13199">https://github.com/scipy/scipy/pull/13199</a>>`__: [skip travis] DOC: 1.6.0 release notes<br>* `#13203 <<a href="https://github.com/scipy/scipy/pull/13203">https://github.com/scipy/scipy/pull/13203</a>>`__: fix typos<br>* `#13209 <<a href="https://github.com/scipy/scipy/pull/13209">https://github.com/scipy/scipy/pull/13209</a>>`__: TST:linalg: set the seed for cossin test<br>* `#13212 <<a href="https://github.com/scipy/scipy/pull/13212">https://github.com/scipy/scipy/pull/13212</a>>`__: [DOC] Backtick and directive consistency.<br>* `#13217 <<a href="https://github.com/scipy/scipy/pull/13217">https://github.com/scipy/scipy/pull/13217</a>>`__: REL: add necessary setuptools and numpy version pins in pyproject.toml...<br>* `#13226 <<a href="https://github.com/scipy/scipy/pull/13226">https://github.com/scipy/scipy/pull/13226</a>>`__: BUG: pavement.py file handle fixes<br>* `#13249 <<a href="https://github.com/scipy/scipy/pull/13249">https://github.com/scipy/scipy/pull/13249</a>>`__: Handle cval correctly for ndimage functions with complex-valued...<br>* `#13253 <<a href="https://github.com/scipy/scipy/pull/13253">https://github.com/scipy/scipy/pull/13253</a>>`__: BUG,MAINT: Ensure all Pool objects are closed<br>* `#13255 <<a href="https://github.com/scipy/scipy/pull/13255">https://github.com/scipy/scipy/pull/13255</a>>`__: BUG:linalg: Fix heevx wrappers and add new tests<br>* `#13260 <<a href="https://github.com/scipy/scipy/pull/13260">https://github.com/scipy/scipy/pull/13260</a>>`__: CI: fix macOS testing<br>* `#13269 <<a href="https://github.com/scipy/scipy/pull/13269">https://github.com/scipy/scipy/pull/13269</a>>`__: CI: github actions: In the linux dbg tests, update apt before...<br>* `#13279 <<a href="https://github.com/scipy/scipy/pull/13279">https://github.com/scipy/scipy/pull/13279</a>>`__: MAINT: 1.6.0 rc2 backports<br><br>Checksums<br>=========<br><br>MD5<br>~~~<br><br>8fd605d90e571560d33eecb3c2263abe  scipy-1.6.0-cp37-cp37m-macosx_10_9_x86_64.whl<br>ab345b6f61228d8d797083fbe4ecb9df  scipy-1.6.0-cp37-cp37m-manylinux1_i686.whl<br>6df40fd888aacc66c7fa2f905fdc3c8b  scipy-1.6.0-cp37-cp37m-manylinux1_x86_64.whl<br>80adc50489f2d1f3f84c71629a7f0233  scipy-1.6.0-cp37-cp37m-manylinux2014_aarch64.whl<br>0f60495e80fd143419c594238b1c9f0a  scipy-1.6.0-cp37-cp37m-win32.whl<br>b7bcb35ae551a0d78139ed5a8f11fbde  scipy-1.6.0-cp37-cp37m-win_amd64.whl<br>fef87b2e8d82638af89c7ff0820033f9  scipy-1.6.0-cp38-cp38-macosx_10_9_x86_64.whl<br>7e7d04505b315c4cc4567ddca2c9f160  scipy-1.6.0-cp38-cp38-manylinux1_i686.whl<br>54e934334700a16d84a62b3cd375085c  scipy-1.6.0-cp38-cp38-manylinux1_x86_64.whl<br>e03550991ed048d919cbe75b8687dab5  scipy-1.6.0-cp38-cp38-manylinux2014_aarch64.whl<br>026724f8bec3081520eda2bad41776bb  scipy-1.6.0-cp38-cp38-win32.whl<br>3a1ff95d9ea373196d3594df2303bfff  scipy-1.6.0-cp38-cp38-win_amd64.whl<br>7653cdb2672fc5bd9609947f05a1a9cf  scipy-1.6.0-cp39-cp39-macosx_10_9_x86_64.whl<br>ac6f387bcfff36b1909783b9e78173c1  scipy-1.6.0-cp39-cp39-manylinux1_i686.whl<br>d9d9aa57714f58da02b3cb539d3bab7e  scipy-1.6.0-cp39-cp39-manylinux1_x86_64.whl<br>ad70a68d2e5190c5bda723fabc877bbe  scipy-1.6.0-cp39-cp39-manylinux2014_aarch64.whl<br>5fcd381d744e9ba272694547750ae9d5  scipy-1.6.0-cp39-cp39-win32.whl<br>fe7ddd09cdc2263f8ecae6001b41f963  scipy-1.6.0-cp39-cp39-win_amd64.whl<br>550fcf08700e0bf0f32dc5c06c0f793a  scipy-1.6.0.tar.gz<br>38acf883207e044e1ac9393a5806c3b9  scipy-1.6.0.tar.xz<br>b67a16099b676cbbfdb977b45776a822  scipy-1.6.0.zip<br><br>SHA256<br>~~~~~~<br><br>3d4303e3e21d07d9557b26a1707bb9fc065510ee8501c9bf22a0157249a82fd0  scipy-1.6.0-cp37-cp37m-macosx_10_9_x86_64.whl<br>1bc5b446600c4ff7ab36bade47180673141322f0febaa555f1c433fe04f2a0e3  scipy-1.6.0-cp37-cp37m-manylinux1_i686.whl<br>8840a9adb4ede3751f49761653d3ebf664f25195fdd42ada394ffea8903dd51d  scipy-1.6.0-cp37-cp37m-manylinux1_x86_64.whl<br>8629135ee00cc2182ac8be8e75643b9f02235942443732c2ed69ab48edcb6614  scipy-1.6.0-cp37-cp37m-manylinux2014_aarch64.whl<br>58731bbe0103e96b89b2f41516699db9b63066e4317e31b8402891571f6d358f  scipy-1.6.0-cp37-cp37m-win32.whl<br>876badc33eec20709d4e042a09834f5953ebdac4088d45a4f3a1f18b56885718  scipy-1.6.0-cp37-cp37m-win_amd64.whl<br>c0911f3180de343643f369dc5cfedad6ba9f939c2d516bddea4a6871eb000722  scipy-1.6.0-cp38-cp38-macosx_10_9_x86_64.whl<br>b8af26839ae343655f3ca377a5d5e5466f1d3b3ac7432a43449154fe958ae0e0  scipy-1.6.0-cp38-cp38-manylinux1_i686.whl<br>4f1d9cc977ac6a4a63c124045c1e8bf67ec37098f67c699887a93736961a00ae  scipy-1.6.0-cp38-cp38-manylinux1_x86_64.whl<br>eb7928275f3560d47e5538e15e9f32b3d64cd30ea8f85f3e82987425476f53f6  scipy-1.6.0-cp38-cp38-manylinux2014_aarch64.whl<br>31ab217b5c27ab429d07428a76002b33662f98986095bbce5d55e0788f7e8b15  scipy-1.6.0-cp38-cp38-win32.whl<br>2f1c2ebca6fd867160e70102200b1bd07b3b2d31a3e6af3c58d688c15d0d07b7  scipy-1.6.0-cp38-cp38-win_amd64.whl<br>155225621df90fcd151e25d51c50217e412de717475999ebb76e17e310176981  scipy-1.6.0-cp39-cp39-macosx_10_9_x86_64.whl<br>f68d5761a2d2376e2b194c8e9192bbf7c51306ca176f1a0889990a52ef0d551f  scipy-1.6.0-cp39-cp39-manylinux1_i686.whl<br>d902d3a5ad7f28874c0a82db95246d24ca07ad932741df668595fe00a4819870  scipy-1.6.0-cp39-cp39-manylinux1_x86_64.whl<br>aef3a2dbc436bbe8f6e0b635f0b5fe5ed024b522eee4637dbbe0b974129ca734  scipy-1.6.0-cp39-cp39-manylinux2014_aarch64.whl<br>cdbc47628184a0ebeb5c08f1892614e1bd4a51f6e0d609c6eed253823a960f5b  scipy-1.6.0-cp39-cp39-win32.whl<br>313785c4dab65060f9648112d025f6d2fec69a8a889c714328882d678a95f053  scipy-1.6.0-cp39-cp39-win_amd64.whl<br>cb6dc9f82dfd95f6b9032a8d7ea70efeeb15d5b5fd6ed4e8537bb3c673580566  scipy-1.6.0.tar.gz<br>dd06d02e8ac6e13e973cbab3da63888daf26a4fec1cd8a8d0804ec872864a7f5  scipy-1.6.0.tar.xz<br>b0d5014d41fed5516d93d0c99a41465061b4d01cf4acd5cdc68c3be9e12c8563  scipy-1.6.0.zip<br></span></div></div>