1==========================
2SciPy 1.5.0 Release Notes
3==========================
4
5.. contents::
6
7SciPy 1.5.0 is the culmination of 6 months of hard work. It contains
8many new features, numerous bug-fixes, improved test coverage and better
9documentation. There have been a number of deprecations and API changes
10in this release, which are documented below. All users are encouraged to
11upgrade to this release, as there are a large number of bug-fixes and
12optimizations. Before upgrading, we recommend that users check that
13their own code does not use deprecated SciPy functionality (to do so,
14run your code with ``python -Wd`` and check for ``DeprecationWarning`` s).
15Our development attention will now shift to bug-fix releases on the
161.5.x branch, and on adding new features on the master branch.
17
18This release requires Python 3.6+ and NumPy 1.14.5 or greater.
19
20For running on PyPy, PyPy3 6.0+ and NumPy 1.15.0 are required.
21
22Highlights of this release
23--------------------------
24
25- wrappers for more than a dozen new ``LAPACK`` routines are now available
26  in `scipy.linalg.lapack`
27- Improved support for leveraging 64-bit integer size from linear algebra
28  backends
29- addition of the probability distribution for two-sided one-sample
30  Kolmogorov-Smirnov tests
31
32
33New features
34============
35
36`scipy.cluster` improvements
37------------------------------
38Initialization of `scipy.cluster.vq.kmeans2` using ``minit="++"`` had a
39quadratic complexity in the number of samples. It has been improved, resulting
40in a much faster initialization with quasi-linear complexity.
41
42`scipy.cluster.hierarchy.dendrogram` now respects the ``matplotlib`` color
43palette
44
45`scipy.fft` improvements
46------------------------------
47A new keyword-only argument ``plan`` is added to all FFT functions in this
48module. It is reserved for passing in a precomputed plan from libraries
49providing a FFT backend (such as ``PyFFTW`` and ``mkl-fft``), and it is
50currently not used in SciPy.
51
52`scipy.integrate` improvements
53------------------------------
54
55
56`scipy.interpolate` improvements
57--------------------------------
58
59`scipy.io` improvements
60-----------------------
61`scipy.io.wavfile` error messages are more explicit about what's wrong, and
62extraneous bytes at the ends of files are ignored instead of raising an error
63when the data has successfully been read.
64
65`scipy.io.loadmat` gained a ``simplify_cells`` parameter, which if set to
66``True`` simplifies the structure of the return value if the ``.mat`` file
67contains cell arrays.
68
69``pathlib.Path`` objects are now supported in `scipy.io` Matrix Market I/O
70functions
71
72`scipy.linalg` improvements
73---------------------------
74`scipy.linalg.eigh` has been improved. Now various ``LAPACK`` drivers can be
75selected at will and also subsets of eigenvalues can be requested via
76``subset_by_value`` keyword. Another keyword ``subset_by_index`` is introduced.
77Keywords ``turbo`` and ``eigvals`` are deprecated.
78
79Similarly, standard and generalized Hermitian eigenvalue ``LAPACK`` routines
80``?<sy/he>evx`` are added and existing ones now have full ``_lwork``
81counterparts.
82
83Wrappers for the following ``LAPACK`` routines have been added to
84`scipy.linalg.lapack`:
85
86- ``?getc2``: computes the LU factorization of a general matrix with complete
87    pivoting
88- ``?gesc2``: solves a linear system given an LU factorization from ``?getc2``
89- ``?gejsv``: computes the singular value decomposition of a general matrix
90    with higher accuracy calculation of tiny singular values and their
91    corresponding singular vectors
92- ``?geqrfp``: computes the QR factorization of a general matrix with
93    non-negative elements on the diagonal of R
94- ``?gtsvx``: solves a linear system with general tridiagonal matrix
95- ``?gttrf``: computes the LU factorization of a tridiagonal matrix
96- ``?gttrs``: solves a linear system given an LU factorization from ``?gttrf``
97- ``?ptsvx``: solves a linear system with symmetric positive definite
98    tridiagonal matrix
99- ``?pttrf``: computes the LU factorization of a symmetric positive definite
100    tridiagonal matrix
101- ``?pttrs``: solves a linear system given an LU factorization from ``?pttrf``
102- ``?pteqr``: computes the eigenvectors and eigenvalues of a positive definite
103    tridiagonal matrix
104- ``?tbtrs``: solves a linear system with a triangular banded matrix
105- ``?csd``: computes the Cosine Sine decomposition of an orthogonal/unitary
106    matrix
107
108Generalized QR factorization routines (``?geqrf``) now have full ``_lwork``
109counterparts.
110
111`scipy.linalg.cossin` Cosine Sine decomposition of unitary matrices has been
112added.
113
114The function `scipy.linalg.khatri_rao`, which computes the Khatri-Rao product,
115was added.
116
117The new function `scipy.linalg.convolution_matrix` constructs the Toeplitz
118matrix representing one-dimensional convolution.
119
120`scipy.ndimage` improvements
121----------------------------
122
123
124`scipy.optimize` improvements
125-----------------------------
126The finite difference numerical differentiation used in various ``minimize``
127methods that use gradients has several new features:
128
129- 2-point, 3-point, or complex step finite differences can be used. Previously
130  only a 2-step finite difference was available.
131- There is now the possibility to use a relative step size, previously only an
132  absolute step size was available.
133- If the ``minimize`` method uses bounds the numerical differentiation strictly
134  obeys those limits.
135- The numerical differentiation machinery now makes use of a simple cache,
136  which in some cases can reduce the number of function evaluations.
137- ``minimize``'s ``method= 'powell'`` now supports simple bound constraints
138
139There have been several improvements to `scipy.optimize.linprog`:
140
141- The ``linprog`` benchmark suite has been expanded considerably.
142- ``linprog``'s dense pivot-based redundancy removal routine and sparse
143  presolve are faster
144- When ``scikit-sparse`` is available, solving sparse problems with
145  ``method='interior-point'`` is faster
146
147The caching of values when optimizing a function returning both value and
148gradient together has been improved, avoiding repeated function evaluations
149when using a ``HessianApproximation`` such as ``BFGS``.
150
151``differential_evolution`` can now use the modern ``np.random.Generator`` as
152well as the legacy ``np.random.RandomState`` as a seed.
153
154`scipy.signal` improvements
155---------------------------
156A new optional argument ``include_nyquist`` is added to ``freqz`` functions in
157this module. It is used for including the last frequency (Nyquist frequency).
158
159`scipy.signal.find_peaks_cwt` now accepts a ``window_size`` parameter for the
160size of the window used to calculate the noise floor.
161
162`scipy.sparse` improvements
163---------------------------
164Outer indexing is now faster when using a 2d column vector to select column
165indices.
166
167`scipy.sparse.lil.tocsr` is faster
168
169Fixed/improved comparisons between pydata sparse arrays and sparse matrices
170
171BSR format sparse multiplication performance has been improved.
172
173`scipy.sparse.linalg.LinearOperator` has gained the new ``ndim`` class
174attribute
175
176`scipy.spatial` improvements
177----------------------------
178`scipy.spatial.geometric_slerp` has been added to enable geometric
179spherical linear interpolation on an n-sphere
180
181`scipy.spatial.SphericalVoronoi` now supports calculation of region areas in 2D
182and 3D cases
183
184The tree building algorithm used by ``cKDTree`` has improved from quadratic
185worst case time complexity to loglinear. Benchmarks are also now available for
186building and querying of balanced/unbalanced kd-trees.
187
188`scipy.special` improvements
189----------------------------
190The following functions now have Cython interfaces in `cython_special`:
191
192- `scipy.special.erfinv`
193- `scipy.special.erfcinv`
194- `scipy.special.spherical_jn`
195- `scipy.special.spherical_yn`
196- `scipy.special.spherical_in`
197- `scipy.special.spherical_kn`
198
199`scipy.special.log_softmax` has been added to calculate the logarithm of softmax
200function. It provides better accuracy than ``log(scipy.special.softmax(x))`` for
201inputs that make softmax saturate.
202
203`scipy.stats` improvements
204--------------------------
205The function for generating random samples in `scipy.stats.dlaplace` has been
206improved. The new function is approximately twice as fast with a memory
207footprint reduction between 25 % and 60 % (see gh-11069).
208
209`scipy.stats` functions that accept a seed for reproducible calculations using
210random number generation (e.g. random variates from distributions) can now use
211the modern ``np.random.Generator`` as well as the legacy
212``np.random.RandomState`` as a seed.
213
214The ``axis`` parameter was added to `scipy.stats.rankdata`. This allows slices
215of an array along the given axis to be ranked independently.
216
217The ``axis`` parameter was added to `scipy.stats.f_oneway`, allowing it to
218compute multiple one-way ANOVA tests for data stored in n-dimensional
219arrays.  The performance of ``f_oneway`` was also improved for some cases.
220
221The PDF and CDF methods for ``stats.geninvgauss`` are now significantly faster
222as  the numerical integration to calculate the CDF uses a Cython based
223``LowLevelCallable``.
224
225Moments of the normal distribution (`scipy.stats.norm`) are now calculated using
226analytical formulas instead of numerical integration for greater speed and
227accuracy
228
229Moments and entropy trapezoidal distribution (``scipy.stats.trapz``) are now
230calculated using analytical formulas instead of numerical integration for
231greater speed and accuracy
232
233Methods of the truncated normal distribution (`scipy.stats.truncnorm`),
234especially ``_rvs``, are significantly faster after a complete rewrite.
235
236The `fit` method of the Laplace distribution,  `scipy.stats.laplace`, now uses
237the analytical formulas for the maximum likelihood estimates of the parameters.
238
239Generation of random variates is now thread safe for all SciPy distributions.
2403rd-party distributions may need to modify the signature of the ``_rvs()``
241method to conform to ``_rvs(self, ..., size=None, random_state=None)``. (A
242one-time VisibleDeprecationWarning is emitted when using non-conformant
243distributions.)
244
245The Kolmogorov-Smirnov two-sided test statistic distribution
246(`scipy.stats.kstwo`) was added. Calculates the distribution of the K-S
247two-sided statistic ``D_n`` for a sample of size n, using a mixture of exact
248and asymptotic algorithms.
249
250The new function ``median_abs_deviation`` replaces the deprecated
251``median_absolute_deviation``.
252
253The ``wilcoxon`` function now computes the p-value for Wilcoxon's signed rank
254test using the exact distribution for inputs up to length 25.  The function has
255a new ``mode`` parameter to specify how the p-value is to be computed.  The
256default is ``"auto"``, which uses the exact distribution for inputs up to length
25725 and the normal approximation for larger inputs.
258
259Added a new Cython-based implementation to evaluate guassian kernel estimates,
260which should improve the performance of ``gaussian_kde``
261
262The ``winsorize`` function now has a ``nan_policy`` argument for refined
263handling of ``nan`` input values.
264
265The ``binned_statistic_dd`` function with ``statistic="std"`` performance was
266improved by ~4x.
267
268``scipy.stats.kstest(rvs, cdf,...)`` now handles both one-sample and
269two-sample testing. The one-sample variation uses `scipy.stats.ksone`
270(or `scipy.stats.kstwo` with back off to `scipy.stats.kstwobign`) to calculate
271the p-value. The two-sample variation, invoked if ``cdf`` is array_like, uses
272an algorithm described by Hodges to compute the probability directly, only
273backing off to `scipy.stats.kstwo` in case of overflow. The result in both
274cases is more accurate p-values, especially for two-sample testing with
275smaller (or quite different) sizes.
276
277`scipy.stats.maxwell` performance improvements include a 20 % speed up for
278`fit()`` and 5 % for ``pdf()``
279
280`scipy.stats.shapiro` and `scipy.stats.jarque_bera` now return a named tuple
281for greater consistency with other ``stats`` functions
282
283Deprecated features
284===================
285
286`scipy` deprecations
287--------------------
288
289`scipy.special` changes
290-----------------------
291The ``bdtr``, ``bdtrc``, and ``bdtri`` functions are deprecating non-negative
292non-integral ``n`` arguments.
293
294`scipy.stats` changes
295---------------------
296The function ``median_absolute_deviation`` is deprecated. Use
297``median_abs_deviation`` instead.
298
299The use of the string ``"raw"`` with the ``scale`` parameter of ``iqr`` is
300deprecated. Use ``scale=1`` instead.
301
302Backwards incompatible changes
303==============================
304
305`scipy.interpolate` changes
306---------------------------
307
308`scipy.linalg` changes
309----------------------
310The output signatures of ``?syevr``, ``?heevr`` have been changed from
311``w, v, info`` to ``w, v, m, isuppz, info``
312
313The order of output arguments ``w``, ``v`` of ``<sy/he>{gv, gvd, gvx}`` is
314swapped.
315
316`scipy.signal` changes
317----------------------
318The output length of `scipy.signal.upfirdn` has been corrected, resulting
319outputs may now be shorter for some combinations of up/down ratios and input
320signal and filter lengths.
321
322`scipy.signal.resample` now supports a ``domain`` keyword argument for
323specification of time or frequency domain input.
324
325`scipy.stats` changes
326---------------------
327
328
329Other changes
330=============
331Improved support for leveraging 64-bit integer size from linear algebra backends
332in several parts of the SciPy codebase.
333
334Shims designed to ensure the compatibility of SciPy with Python 2.7 have now
335been removed.
336
337Many warnings due to unused imports and unused assignments have been addressed.
338
339Many usage examples were added to function docstrings, and many input
340validations and intuitive exception messages have been added throughout the
341codebase.
342
343Early stage adoption of type annotations in a few parts of the codebase
344
345
346Authors
347=======
348
349* @endolith
350* Hameer Abbasi
351* ADmitri +
352* Wesley Alves +
353* Berkay Antmen +
354* Sylwester Arabas +
355* Arne Küderle +
356* Christoph Baumgarten
357* Peter Bell
358* Felix Berkenkamp
359* Jordão Bragantini +
360* Clemens Brunner +
361* Evgeni Burovski
362* Matthias Bussonnier +
363* CJ Carey
364* Derrick Chambers +
365* Leander Claes +
366* Christian Clauss
367* Luigi F. Cruz +
368* dankleeman
369* Andras Deak
370* Milad Sadeghi DM +
371* jeremie du boisberranger +
372* Stefan Endres
373* Malte Esders +
374* Leo Fang +
375* felixhekhorn +
376* Isuru Fernando
377* Andrew Fowlie
378* Lakshay Garg +
379* Gaurav Gijare +
380* Ralf Gommers
381* Emmanuelle Gouillart +
382* Kevin Green +
383* Martin Grignard +
384* Maja Gwozdz
385* Sturla Molden
386* gyu-don +
387* Matt Haberland
388* hakeemo +
389* Charles Harris
390* Alex Henrie
391* Santi Hernandez +
392* William Hickman +
393* Till Hoffmann +
394* Joseph T. Iosue +
395* Anany Shrey Jain
396* Jakob Jakobson
397* Charles Jekel +
398* Julien Jerphanion +
399* Jiacheng-Liu +
400* Christoph Kecht +
401* Paul Kienzle +
402* Reidar Kind +
403* Dmitry E. Kislov +
404* Konrad +
405* Konrad0
406* Takuya KOUMURA +
407* Krzysztof Pióro
408* Peter Mahler Larsen
409* Eric Larson
410* Antony Lee
411* Gregory Lee +
412* Gregory R. Lee
413* Chelsea Liu
414* Cong Ma +
415* Kevin Mader +
416* Maja Gwóźdź +
417* Alex Marvin +
418* Matthias Kümmerer
419* Nikolay Mayorov
420* Mazay0 +
421* G. D. McBain
422* Nicholas McKibben +
423* Sabrina J. Mielke +
424* Sebastian J. Mielke +
425* Miloš Komarčević +
426* Shubham Mishra +
427* Santiago M. Mola +
428* Grzegorz Mrukwa +
429* Peyton Murray
430* Andrew Nelson
431* Nico Schlömer
432* nwjenkins +
433* odidev +
434* Sambit Panda
435* Vikas Pandey +
436* Rick Paris +
437* Harshal Prakash Patankar +
438* Balint Pato +
439* Matti Picus
440* Ilhan Polat
441* poom +
442* Siddhesh Poyarekar
443* Vladyslav Rachek +
444* Bharat Raghunathan
445* Manu Rajput +
446* Tyler Reddy
447* Andrew Reed +
448* Lucas Roberts
449* Ariel Rokem
450* Heshy Roskes
451* Matt Ruffalo
452* Atsushi Sakai +
453* Benjamin Santos +
454* Christoph Schock +
455* Lisa Schwetlick +
456* Chris Simpson +
457* Leo Singer
458* Kai Striega
459* Søren Fuglede Jørgensen
460* Kale-ab Tessera +
461* Seth Troisi +
462* Robert Uhl +
463* Paul van Mulbregt
464* Vasiliy +
465* Isaac Virshup +
466* Pauli Virtanen
467* Shakthi Visagan +
468* Jan Vleeshouwers +
469* Sam Wallan +
470* Lijun Wang +
471* Warren Weckesser
472* Richard Weiss +
473* wenhui-prudencemed +
474* Eric Wieser
475* Josh Wilson
476* James Wright +
477* Ruslan Yevdokymov +
478* Ziyao Zhang +
479
480A total of 129 people contributed to this release.
481People with a "+" by their names contributed a patch for the first time.
482This list of names is automatically generated, and may not be fully complete.
483
484Issues closed for 1.5.0
485-----------------------
486
487* `#1455 <https://github.com/scipy/scipy/issues/1455>`__: ellipord does returns bogus values if gstop or gpass are negative...
488* `#1968 <https://github.com/scipy/scipy/issues/1968>`__: correlate2d's output does not agree with correlate's output in...
489* `#2744 <https://github.com/scipy/scipy/issues/2744>`__: BUG: optimize: '\*\*kw' argument of 'newton_krylov' is not documented
490* `#4755 <https://github.com/scipy/scipy/issues/4755>`__: TypeError: data type "<i0" not understood
491* `#4921 <https://github.com/scipy/scipy/issues/4921>`__: scipy.optimize maxiter option not working as expected
492* `#5144 <https://github.com/scipy/scipy/issues/5144>`__: RuntimeWarning on csgraph.shortest_path when edge lengths are...
493* `#5309 <https://github.com/scipy/scipy/issues/5309>`__: Documentation of 'hybr' and 'lm' inconsistent in optimize.root
494* `#6026 <https://github.com/scipy/scipy/issues/6026>`__: Replace approx_grad with _numdiff.approx_derivative in scipy.optimize
495* `#6502 <https://github.com/scipy/scipy/issues/6502>`__: Computing Eigenvalues in an Interval with LAPACK
496* `#7058 <https://github.com/scipy/scipy/issues/7058>`__: Errors in special.bdtri and special.bdtr for non-integer k values
497* `#7700 <https://github.com/scipy/scipy/issues/7700>`__: SuperLU does not respect perm_c="NATURAL"
498* `#7895 <https://github.com/scipy/scipy/issues/7895>`__: Improvements to io.loadmat
499* `#8205 <https://github.com/scipy/scipy/issues/8205>`__: ValueError in scipy.linalg.eigvalsh for large matrix
500* `#8278 <https://github.com/scipy/scipy/issues/8278>`__: Memory limit for scipy.sparse.linalg.spsolve with scikit-umfpack
501* `#8327 <https://github.com/scipy/scipy/issues/8327>`__: scipy.stats.mstats.winsorize NaN handling
502* `#8341 <https://github.com/scipy/scipy/issues/8341>`__: scipy.stats.ks_2samp for masked and unmasked data give different...
503* `#8748 <https://github.com/scipy/scipy/issues/8748>`__: scipy.stats.kstest for same distribution: p-values nonuniform
504* `#9042 <https://github.com/scipy/scipy/issues/9042>`__: optimize: Incorrect statement about \`jac\` in the \`minimize\`...
505* `#9197 <https://github.com/scipy/scipy/issues/9197>`__: problem with scipy.signal.butter with 1000+ points array
506* `#9212 <https://github.com/scipy/scipy/issues/9212>`__: EIGH very very slow --> suggesting an easy fix
507* `#9553 <https://github.com/scipy/scipy/issues/9553>`__: ndimage routines behave badly when output has memory overlap...
508* `#9632 <https://github.com/scipy/scipy/issues/9632>`__: ndimage.maximum_filter undocumented behaviour using footprint...
509* `#9658 <https://github.com/scipy/scipy/issues/9658>`__: `scipy.optimize.minimize(method='COBYLA')` not threadsafe
510* `#9710 <https://github.com/scipy/scipy/issues/9710>`__: stats.weightedtau([1], [1.0]) SEGFAULTs
511* `#9797 <https://github.com/scipy/scipy/issues/9797>`__: Master Tracker for some Kolmogorov-Smirnov test Issues
512* `#9844 <https://github.com/scipy/scipy/issues/9844>`__: scipy.signal.upfirdn gives different length matrix versus MATLAB...
513* `#9872 <https://github.com/scipy/scipy/issues/9872>`__: scipy.signal.convolve is slower when vectorized
514* `#9913 <https://github.com/scipy/scipy/issues/9913>`__: BUG: No dt in StateSpace operations
515* `#10014 <https://github.com/scipy/scipy/issues/10014>`__: Distribution names \`weibull_min\`and \`weibull_max\` should...
516* `#10159 <https://github.com/scipy/scipy/issues/10159>`__: BUG: stats: chisquare returns incorrect results for arrays of...
517* `#10302 <https://github.com/scipy/scipy/issues/10302>`__: scipy.fft: Add a \`plan\` argument
518* `#10332 <https://github.com/scipy/scipy/issues/10332>`__: 'Incomplete wav chunk' inconsistent/reason unknown
519* `#10441 <https://github.com/scipy/scipy/issues/10441>`__: Remove uses of \`numpy.dual\`?
520* `#10558 <https://github.com/scipy/scipy/issues/10558>`__: Document implicit sum in csr_matrix() constructor
521* `#10788 <https://github.com/scipy/scipy/issues/10788>`__: LU with full pivoting
522* `#10841 <https://github.com/scipy/scipy/issues/10841>`__: Unexpected behavior in linalg.blas.dtrmm wrapper
523* `#10919 <https://github.com/scipy/scipy/issues/10919>`__: optimize._lbfgsb setulb() function violates parameter bounds
524* `#10963 <https://github.com/scipy/scipy/issues/10963>`__: kstest, ks_2samp: confusing \`mode\` argument descriptions
525* `#11022 <https://github.com/scipy/scipy/issues/11022>`__: Unexpected Result in factorial function with NaN input
526* `#11028 <https://github.com/scipy/scipy/issues/11028>`__: Documentation error in optimize.minimize
527* `#11058 <https://github.com/scipy/scipy/issues/11058>`__: Adding logsoftmax function
528* `#11076 <https://github.com/scipy/scipy/issues/11076>`__: ValueError: Unknown wave file format
529* `#11090 <https://github.com/scipy/scipy/issues/11090>`__: Misconception of the median absolute deviation in stats?
530* `#11095 <https://github.com/scipy/scipy/issues/11095>`__: BUG: find_peaks_cwt test failures in 32-bit Linux wheels
531* `#11107 <https://github.com/scipy/scipy/issues/11107>`__: scipy.io.mmread generated an error "TypeError: startswith first...
532* `#11123 <https://github.com/scipy/scipy/issues/11123>`__: Add wrapper for ?gttrf/?gttrs
533* `#11128 <https://github.com/scipy/scipy/issues/11128>`__: OverflowError in resample_poly (upfirdn)
534* `#11132 <https://github.com/scipy/scipy/issues/11132>`__: Possible bug: rv_discret.ppf for percentiles 0 and 100 and loc...
535* `#11163 <https://github.com/scipy/scipy/issues/11163>`__: Comparisons between scipy spmatrix and can sparse.SparseArray...
536* `#11168 <https://github.com/scipy/scipy/issues/11168>`__: Generalized Pareto variance inaccurate for concentrations near...
537* `#11169 <https://github.com/scipy/scipy/issues/11169>`__: Add wrapper for ?geqrfp
538* `#11184 <https://github.com/scipy/scipy/issues/11184>`__: 2-sided Kolmogorov Smirnov returns p-value of 1
539* `#11185 <https://github.com/scipy/scipy/issues/11185>`__: The .roots() or solve() function of scipy.interpolate.CubicHermiteSpline...
540* `#11190 <https://github.com/scipy/scipy/issues/11190>`__: Add wrapper for ?tbtrs
541* `#11200 <https://github.com/scipy/scipy/issues/11200>`__: Can no longer slice csr_matrix in 1.3.0
542* `#11207 <https://github.com/scipy/scipy/issues/11207>`__: _minimize_scalar_bounded: reference before assignment
543* `#11216 <https://github.com/scipy/scipy/issues/11216>`__: linprog: interior-point: Cholmod reordering can be reused
544* `#11223 <https://github.com/scipy/scipy/issues/11223>`__: Add wrappers for ?pttrf, ?pttrs
545* `#11224 <https://github.com/scipy/scipy/issues/11224>`__: Add wrapperfor ?pteqr
546* `#11235 <https://github.com/scipy/scipy/issues/11235>`__: MAINT: Missleading Error Message for IIR Filter
547* `#11244 <https://github.com/scipy/scipy/issues/11244>`__: Missing reference in \`scipy.optimize.line_search\`
548* `#11262 <https://github.com/scipy/scipy/issues/11262>`__: Hermitian Eigenvalue Problem eigh() API and wrapper change proposal
549* `#11266 <https://github.com/scipy/scipy/issues/11266>`__: Sparse matrix constructor data type detection changes on Numpy...
550* `#11270 <https://github.com/scipy/scipy/issues/11270>`__: CI failing: Travis CI Py36 refguide and Linux_Python_36_32bit_full...
551* `#11279 <https://github.com/scipy/scipy/issues/11279>`__: linalg.eigh checks whole array for finite values
552* `#11295 <https://github.com/scipy/scipy/issues/11295>`__: CI: azure does not auto-cancel old jobs on pushes
553* `#11299 <https://github.com/scipy/scipy/issues/11299>`__: stats.truncnorm.rvs 100x slower in v1.4.x than v1.3.3
554* `#11315 <https://github.com/scipy/scipy/issues/11315>`__: BUG: special: rgamma on negative integers smaller -34
555* `#11319 <https://github.com/scipy/scipy/issues/11319>`__: Missing \`int64_t\` declaration in rectangular_lsap.cpp
556* `#11323 <https://github.com/scipy/scipy/issues/11323>`__: Compilation failure due to missing symbol pthread_atfork
557* `#11332 <https://github.com/scipy/scipy/issues/11332>`__: BUG: directed_hausdorff distance on sets u and v when u is a...
558* `#11350 <https://github.com/scipy/scipy/issues/11350>`__: Khatri-Rao product
559* `#11354 <https://github.com/scipy/scipy/issues/11354>`__: ENH: Add wrapper for ?gejsv
560* `#11361 <https://github.com/scipy/scipy/issues/11361>`__: Dropped NaN in eval_genlaguerre function
561* `#11363 <https://github.com/scipy/scipy/issues/11363>`__: Dropped NaN in hyperu function
562* `#11365 <https://github.com/scipy/scipy/issues/11365>`__: scipy.stats.binned_statistic regressed in v1.4.0
563* `#11369 <https://github.com/scipy/scipy/issues/11369>`__: Dropped NaN in eval_hermite
564* `#11370 <https://github.com/scipy/scipy/issues/11370>`__: Dropped NaN in eval_gegenbauer
565* `#11373 <https://github.com/scipy/scipy/issues/11373>`__: Add wrapper for ?gtsvx
566* `#11374 <https://github.com/scipy/scipy/issues/11374>`__: Add wrapper for ?ptsvx
567* `#11391 <https://github.com/scipy/scipy/issues/11391>`__: csgraph.minimum_spanning_tree loses precision
568* `#11398 <https://github.com/scipy/scipy/issues/11398>`__: Update stats to cope with \`np.random.Generator\` machinery
569* `#11412 <https://github.com/scipy/scipy/issues/11412>`__: Array copying causes unwanted type casting from complex to float...
570* `#11415 <https://github.com/scipy/scipy/issues/11415>`__: Where is the Wiener Filter derived from?
571* `#11416 <https://github.com/scipy/scipy/issues/11416>`__: _lib._util.getargspec_no_self is missing KEYWORD_ONLY support
572* `#11428 <https://github.com/scipy/scipy/issues/11428>`__: Documentation on SHGO inequality constraints appears contradictory
573* `#11429 <https://github.com/scipy/scipy/issues/11429>`__: Add LAPACK's ZUNCSD cosine sine decomposition
574* `#11438 <https://github.com/scipy/scipy/issues/11438>`__: run_dualannealing passes bounds incorrectly in benchmarks/optimize.py
575* `#11441 <https://github.com/scipy/scipy/issues/11441>`__: Can't run optimize benchmarks
576* `#11442 <https://github.com/scipy/scipy/issues/11442>`__: Chebyshev weights
577* `#11448 <https://github.com/scipy/scipy/issues/11448>`__: Wrongly typed comparison in integrate.quad
578* `#11458 <https://github.com/scipy/scipy/issues/11458>`__: BUG: maximum_bipartite_matching produces infeasible solution
579* `#11460 <https://github.com/scipy/scipy/issues/11460>`__: CI failing: 2 Travis CI tests fail with numpy build or version...
580* `#11462 <https://github.com/scipy/scipy/issues/11462>`__: Bug on "++" initialization on "kmeans2"
581* `#11464 <https://github.com/scipy/scipy/issues/11464>`__: Shouldn't data type of KDE evaluation should be like in the input...
582* `#11468 <https://github.com/scipy/scipy/issues/11468>`__: performance of binned_statistics_2d 100x slowdown from 1.3.2...
583* `#11484 <https://github.com/scipy/scipy/issues/11484>`__: Callback function doesn't give the same value as the one being...
584* `#11492 <https://github.com/scipy/scipy/issues/11492>`__: Confusing dendrogram labelling
585* `#11493 <https://github.com/scipy/scipy/issues/11493>`__: scipy.optimize.least_squares fails if the return array of the...
586* `#11494 <https://github.com/scipy/scipy/issues/11494>`__: Error performing kronecker product between large sparse vectors
587* `#11503 <https://github.com/scipy/scipy/issues/11503>`__: medfilt produces 0 on input of length 1
588* `#11529 <https://github.com/scipy/scipy/issues/11529>`__: Pyflakes generates almost 700 warnings.
589* `#11566 <https://github.com/scipy/scipy/issues/11566>`__: irfft/irfft2/irfftn docs are slightly confusing re: input type.
590* `#11572 <https://github.com/scipy/scipy/issues/11572>`__: least_squares: too small tolerances not catched with method='lm'
591* `#11581 <https://github.com/scipy/scipy/issues/11581>`__: DOC: scipy.interpolate.RectSphereBivariateSpline
592* `#11586 <https://github.com/scipy/scipy/issues/11586>`__: Differential evolution breaks with LinearConstraints with sparse...
593* `#11595 <https://github.com/scipy/scipy/issues/11595>`__: scipy.spatial.cKDTree construction slow for some datasets
594* `#11598 <https://github.com/scipy/scipy/issues/11598>`__: output of special.voigt_profile when sigma=0
595* `#11601 <https://github.com/scipy/scipy/issues/11601>`__: linalg tests failing in runtests.py
596* `#11602 <https://github.com/scipy/scipy/issues/11602>`__: scipy.optimize.linear_sum_assignment returns reverse diagonal...
597* `#11610 <https://github.com/scipy/scipy/issues/11610>`__: Analytic formula for normal moments
598* `#11611 <https://github.com/scipy/scipy/issues/11611>`__: Build failure with gfortran 10
599* `#11613 <https://github.com/scipy/scipy/issues/11613>`__: TST, MAINT: test_quadpack TestCtypesQuad wasn't fully migrated...
600* `#11630 <https://github.com/scipy/scipy/issues/11630>`__: SmoothBivariateSpline bbox parameter
601* `#11635 <https://github.com/scipy/scipy/issues/11635>`__: typo in docstring of scipy.stats.norminvgauss
602* `#11637 <https://github.com/scipy/scipy/issues/11637>`__: BUG: core dumps when calling scipy.interpolate.interp1d with...
603* `#11638 <https://github.com/scipy/scipy/issues/11638>`__: better documentation for 'return_all' option in minimize(Nelder...
604* `#11652 <https://github.com/scipy/scipy/issues/11652>`__: TST, MAINT: CI failures for pre-release NumPy wheels
605* `#11659 <https://github.com/scipy/scipy/issues/11659>`__: optimize.fmin_l_bfgs_b needs bound check and appropiate error...
606* `#11660 <https://github.com/scipy/scipy/issues/11660>`__: BUG/ENH: distribution.ncf with nc=0 returns nan
607* `#11661 <https://github.com/scipy/scipy/issues/11661>`__: scipy.ndimage.convolve1d and correlate1d don't behave properly...
608* `#11669 <https://github.com/scipy/scipy/issues/11669>`__: p-value varies with the order of the data
609* `#11676 <https://github.com/scipy/scipy/issues/11676>`__: documentation of scipy.spatial.HalfspaceIntersection: wrong method...
610* `#11685 <https://github.com/scipy/scipy/issues/11685>`__: Rotation cannot be expressed as matrix
611* `#11686 <https://github.com/scipy/scipy/issues/11686>`__: MAINT: mypy imports of Cython "modules"
612* `#11693 <https://github.com/scipy/scipy/issues/11693>`__: TestDifferentialEvolutionSolver::test_L4 failing in CI
613* `#11696 <https://github.com/scipy/scipy/issues/11696>`__: DOC: incorrect compiler information for macOS in docs
614* `#11709 <https://github.com/scipy/scipy/issues/11709>`__: eigh() tests fail to pass, crash Python with seemingly ramdom...
615* `#11763 <https://github.com/scipy/scipy/issues/11763>`__: Small error in gamma continuous rv fit comments
616* `#11769 <https://github.com/scipy/scipy/issues/11769>`__: truncnorm.rvs Weird Behaviors
617* `#11770 <https://github.com/scipy/scipy/issues/11770>`__: crash in TestEigh::test_value_subsets
618* `#11795 <https://github.com/scipy/scipy/issues/11795>`__: trapz distribution mean computed using single precision
619* `#11800 <https://github.com/scipy/scipy/issues/11800>`__: Segmentation fault in scipy.odr for multidimensional independent...
620* `#11811 <https://github.com/scipy/scipy/issues/11811>`__: pyflakes silently failing on travis-ci
621* `#11826 <https://github.com/scipy/scipy/issues/11826>`__: Error with _fblas
622* `#11827 <https://github.com/scipy/scipy/issues/11827>`__: \`fft.tests.test_numpy.test_multiprocess\` hangs on Python3.8...
623* `#11835 <https://github.com/scipy/scipy/issues/11835>`__: tests with \`multiprocessing\` hang on Python 3.8 on macOS
624* `#11839 <https://github.com/scipy/scipy/issues/11839>`__: linalg.expm returns nans with RuntimeWarning: overflow encountered...
625* `#11856 <https://github.com/scipy/scipy/issues/11856>`__: Documentation of fit methods for \`weibull_min\` and \`exponweib\`...
626* `#11868 <https://github.com/scipy/scipy/issues/11868>`__: Function always evaluated twice when using HessianUpdateStrategy...
627* `#11875 <https://github.com/scipy/scipy/issues/11875>`__: Typo in the docstring of simps()
628* `#11877 <https://github.com/scipy/scipy/issues/11877>`__: kmeans2 '++' method is orders of magnitude slower than sklearn.cluster.KMeans()
629* `#11884 <https://github.com/scipy/scipy/issues/11884>`__: The upper code lines are dead code
630* `#11886 <https://github.com/scipy/scipy/issues/11886>`__: Array shape mismatch in scipy.optimize
631* `#11892 <https://github.com/scipy/scipy/issues/11892>`__: BUG: stats: Incorrect handling of edges cases by ttest_rel and...
632* `#11908 <https://github.com/scipy/scipy/issues/11908>`__: LinearOperator should have ndim attribute
633* `#11910 <https://github.com/scipy/scipy/issues/11910>`__: Documentation missing for what M is in init argument
634* `#11922 <https://github.com/scipy/scipy/issues/11922>`__: macOS actions CI has started failing in last couple of days.
635* `#11928 <https://github.com/scipy/scipy/issues/11928>`__: DOC: signal: Wrong description for sepfir2d, cspline2d, qspline2d
636* `#11944 <https://github.com/scipy/scipy/issues/11944>`__: curve_fit documentation unclear on default value of absolute_sigma
637* `#11945 <https://github.com/scipy/scipy/issues/11945>`__: Add a (potentially temporary) py.typed file?
638* `#11949 <https://github.com/scipy/scipy/issues/11949>`__: ValueError 'k exceeds matrix dimensions' for sparse.diagonal()...
639* `#11951 <https://github.com/scipy/scipy/issues/11951>`__: BUG: asv benchmark failed because of cython version
640* `#11967 <https://github.com/scipy/scipy/issues/11967>`__: BLD: Azure windows runs complain about drives
641* `#11973 <https://github.com/scipy/scipy/issues/11973>`__: oaconvolve(a,b,'same') differs in shape from convolve(a,b,'same')...
642* `#12002 <https://github.com/scipy/scipy/issues/12002>`__: pybind11 license
643* `#12003 <https://github.com/scipy/scipy/issues/12003>`__: MAINT: circular SphericalVoronoi input
644* `#12015 <https://github.com/scipy/scipy/issues/12015>`__: Reordering of CSC matrix breaks when you go above int32 limits
645* `#12031 <https://github.com/scipy/scipy/issues/12031>`__: Documentation Rendering Issues Visible in CircleCI Artifacts
646* `#12037 <https://github.com/scipy/scipy/issues/12037>`__: MAINT, CI: new Cython 3.0a4 issue
647* `#12087 <https://github.com/scipy/scipy/issues/12087>`__: DOC: some odr models are missing docs
648* `#12119 <https://github.com/scipy/scipy/issues/12119>`__: signal.fftconvolve no longer convolves types f8 and numpy.float64
649* `#12149 <https://github.com/scipy/scipy/issues/12149>`__: Documentation of Rosenbrock function
650* `#12173 <https://github.com/scipy/scipy/issues/12173>`__: Large memory usage when indexing sparse matrices with \`np.ix_\`
651* `#12178 <https://github.com/scipy/scipy/issues/12178>`__: BUG: stats: Some discrete distributions don't accept lists of...
652* `#12220 <https://github.com/scipy/scipy/issues/12220>`__: BUG, REL: gh_lists.py compromised scraping
653* `#12239 <https://github.com/scipy/scipy/issues/12239>`__: BUG: median absolute deviation handling of nan
654* `#12301 <https://github.com/scipy/scipy/issues/12301>`__: integer overflow in scipy.sparse.sputils.check_shape when matrix size > 2^32
655* `#12314 <https://github.com/scipy/scipy/issues/12314>`__: scipy.spatial.transform.Rotation multiplication does not normalize quaternion
656
657Pull requests for 1.5.0
658-----------------------
659
660* `#6510 <https://github.com/scipy/scipy/pull/6510>`__: Add Eigenvalue Range Functionality for Symmetric Eigenvalue Problems
661* `#9525 <https://github.com/scipy/scipy/pull/9525>`__: BUG: SuperLU 'NATURAL' order applies a column permutation
662* `#9634 <https://github.com/scipy/scipy/pull/9634>`__: Add the number of Jacobian evaluations to the output of L-BFGS-B.
663* `#9719 <https://github.com/scipy/scipy/pull/9719>`__: ENH: Added kstwo probability distribution for two-sided one-sample...
664* `#9783 <https://github.com/scipy/scipy/pull/9783>`__: WIP: optimize: added (dense) interpolative decomposition redundancy...
665* `#10053 <https://github.com/scipy/scipy/pull/10053>`__: Adding docstring to weibull_min and weibull_max based on issue...
666* `#10136 <https://github.com/scipy/scipy/pull/10136>`__: DEP: Add warning to linprog_verbose_callback
667* `#10380 <https://github.com/scipy/scipy/pull/10380>`__: ENH: add geometric_slerp
668* `#10602 <https://github.com/scipy/scipy/pull/10602>`__: MAINT: optimize: refactor common linprog arguments into namedtuple
669* `#10648 <https://github.com/scipy/scipy/pull/10648>`__: Bounds for the Powell minimization method
670* `#10673 <https://github.com/scipy/scipy/pull/10673>`__: ENH: approx_fprime --> approx_derivative
671* `#10759 <https://github.com/scipy/scipy/pull/10759>`__: ENH: calculation of region areas in spatial.SphericalVoronoi
672* `#10762 <https://github.com/scipy/scipy/pull/10762>`__: BENCH: optimize: more comprehensive linprog benchmarking
673* `#10796 <https://github.com/scipy/scipy/pull/10796>`__: ENH exact p-values of wilcoxon test in scipy.stats
674* `#10797 <https://github.com/scipy/scipy/pull/10797>`__: ENH: linalg: LU with full pivoting (wrappers for ?getc2/?gesc2)
675* `#10824 <https://github.com/scipy/scipy/pull/10824>`__: ENH: Fast gaussian kernel estimator
676* `#10942 <https://github.com/scipy/scipy/pull/10942>`__: BUG: prevent bound violation in L-BFGS-B optimize method
677* `#11003 <https://github.com/scipy/scipy/pull/11003>`__: ENH: add scipy.linalg.convolution_matrix
678* `#11023 <https://github.com/scipy/scipy/pull/11023>`__: improving error message for cubic-interpolate with duplicates
679* `#11045 <https://github.com/scipy/scipy/pull/11045>`__: MAINT: make bdt{r,rc,ri}() functions accept double n,k args +...
680* `#11063 <https://github.com/scipy/scipy/pull/11063>`__: Fix documentation error in optimize.minimize
681* `#11069 <https://github.com/scipy/scipy/pull/11069>`__: ENH: stats.dlaplace.rvs improvements
682* `#11071 <https://github.com/scipy/scipy/pull/11071>`__: DOC: Added examples to maximum_position in ndimage
683* `#11075 <https://github.com/scipy/scipy/pull/11075>`__: DOC: Update stylistic consistency in multiple files
684* `#11097 <https://github.com/scipy/scipy/pull/11097>`__: BUG: stats: fixing chisquare to return correct results for arrays...
685* `#11110 <https://github.com/scipy/scipy/pull/11110>`__: ENH: special: Cythonise erfinv, erfcinv
686* `#11112 <https://github.com/scipy/scipy/pull/11112>`__: BUG: special: Return NaN outside the domain of \`eval_hermite\`
687* `#11114 <https://github.com/scipy/scipy/pull/11114>`__: BUG: special: fix \`hyp1f1\` for nonnegative integral \`a\` and...
688* `#11115 <https://github.com/scipy/scipy/pull/11115>`__: DOC: special: add docstrings for \`kei\`, \`ker\`, \`keip\`,...
689* `#11130 <https://github.com/scipy/scipy/pull/11130>`__: ENH: support for circular input
690* `#11136 <https://github.com/scipy/scipy/pull/11136>`__: BUG: expm handling of empty input
691* `#11138 <https://github.com/scipy/scipy/pull/11138>`__: DOC: stylistic consistency, punctuation, etc.
692* `#11139 <https://github.com/scipy/scipy/pull/11139>`__: MAINT: cluster: use cython_blas, remove handwritten BLAS wrappers
693* `#11146 <https://github.com/scipy/scipy/pull/11146>`__: DOC: update docs on bp parameter for detrend
694* `#11151 <https://github.com/scipy/scipy/pull/11151>`__: DOC: special: add docstrings for \`bei\`, \`ber\`, \`beip\`,...
695* `#11156 <https://github.com/scipy/scipy/pull/11156>`__: ENH: add input validation for ellipord.
696* `#11157 <https://github.com/scipy/scipy/pull/11157>`__: DOC: stylistic revision, punctuation, consistency
697* `#11160 <https://github.com/scipy/scipy/pull/11160>`__: ignore warning on 0 \* inf in basin hopping
698* `#11162 <https://github.com/scipy/scipy/pull/11162>`__: DOC: minor stylistic revision, undo changes
699* `#11164 <https://github.com/scipy/scipy/pull/11164>`__: ENH/ BUG: Pydata sparse equality
700* `#11171 <https://github.com/scipy/scipy/pull/11171>`__: Fix dtype validation of "seuclidean" metric V parameter
701* `#11177 <https://github.com/scipy/scipy/pull/11177>`__: BUG: stats: Improve genpareto stats calculations.
702* `#11180 <https://github.com/scipy/scipy/pull/11180>`__: MAINT: stats: Some clean up in test_distributions.py.
703* `#11187 <https://github.com/scipy/scipy/pull/11187>`__: ENH: add functionality log_softmax to SciPy.special.
704* `#11188 <https://github.com/scipy/scipy/pull/11188>`__: MAINT: add rvs method to argus in scipy.stats
705* `#11196 <https://github.com/scipy/scipy/pull/11196>`__: DOC: special: add to docstrings of Kelvin zeros functions
706* `#11202 <https://github.com/scipy/scipy/pull/11202>`__: BUG: fix edge counting in shortest_path
707* `#11218 <https://github.com/scipy/scipy/pull/11218>`__: BUG: scipy/interpolate: fix PPoly/Cubic\*Spline roots() extrapolation...
708* `#11225 <https://github.com/scipy/scipy/pull/11225>`__: Add a warning to constant input for spearmanr() function
709* `#11226 <https://github.com/scipy/scipy/pull/11226>`__: Speed up of interior-point method for cholesky solver
710* `#11229 <https://github.com/scipy/scipy/pull/11229>`__: BUG: Explicit dtype specification in _upfirdn.py
711* `#11230 <https://github.com/scipy/scipy/pull/11230>`__: Additional citation for optimize tutorial
712* `#11231 <https://github.com/scipy/scipy/pull/11231>`__: Adds SLSQP test for duplicate f-evals (#10738)
713* `#11236 <https://github.com/scipy/scipy/pull/11236>`__: MAINT: Improved error message for Wn range in iirfilter.
714* `#11245 <https://github.com/scipy/scipy/pull/11245>`__: ENH: optimize: dense redundancy removal routine optimizations
715* `#11247 <https://github.com/scipy/scipy/pull/11247>`__: MAINT: Remove _lib/_numpy_compat.py
716* `#11248 <https://github.com/scipy/scipy/pull/11248>`__: BUG: rv_discrete.ppf() to handle loc
717* `#11251 <https://github.com/scipy/scipy/pull/11251>`__: DOC: add reference for linesearch zoom algorithm
718* `#11253 <https://github.com/scipy/scipy/pull/11253>`__: BUG: fix kendalltau issue where p-value becomes >1
719* `#11254 <https://github.com/scipy/scipy/pull/11254>`__: MAINT: make special.factorial handle nan correctly
720* `#11256 <https://github.com/scipy/scipy/pull/11256>`__: DOC: Updated documentation for scipy.linalg.qr
721* `#11265 <https://github.com/scipy/scipy/pull/11265>`__: Fix: Can no longer slice csr_matrix in 1.3.0
722* `#11267 <https://github.com/scipy/scipy/pull/11267>`__: BUG: Rework the scaling in the ks_2samp two-sided exact test.
723* `#11268 <https://github.com/scipy/scipy/pull/11268>`__: DOC: example of NonLinearConstraint
724* `#11269 <https://github.com/scipy/scipy/pull/11269>`__: Fix: Sparse matrix constructor data type detection changes on...
725* `#11276 <https://github.com/scipy/scipy/pull/11276>`__: BLD: update minimum Python, NumPy, Cython, Pybind11 versions
726* `#11277 <https://github.com/scipy/scipy/pull/11277>`__: MAINT: Cleanup conditionals for unsupported numpy verisons
727* `#11278 <https://github.com/scipy/scipy/pull/11278>`__: MAINT: Cleanup stats.iqr workarounds for unsupported NumPy versions
728* `#11282 <https://github.com/scipy/scipy/pull/11282>`__: TST/CI: improve traceback formatting for test failures
729* `#11284 <https://github.com/scipy/scipy/pull/11284>`__: fix docs & behavior for mode sequences in ndimage filters
730* `#11285 <https://github.com/scipy/scipy/pull/11285>`__: DOC: special: complete the docstrings of Chi-square functions
731* `#11286 <https://github.com/scipy/scipy/pull/11286>`__: BUG: make loadmat/savemat file opening close resources correctly
732* `#11287 <https://github.com/scipy/scipy/pull/11287>`__: CI: skip Azure and TravisCI builds on merges and direct pushes...
733* `#11288 <https://github.com/scipy/scipy/pull/11288>`__: DOC: Fix import in scipy.io.wavfile.read sample code
734* `#11289 <https://github.com/scipy/scipy/pull/11289>`__: BUG: Use context manager for open
735* `#11290 <https://github.com/scipy/scipy/pull/11290>`__: MAINT: Remove _lib._version in favour of _lib._pep440
736* `#11292 <https://github.com/scipy/scipy/pull/11292>`__: DOC: special: add docstrings for various convenience functions
737* `#11293 <https://github.com/scipy/scipy/pull/11293>`__: DOC: special: fix typo in \`chdtri\` docstring
738* `#11296 <https://github.com/scipy/scipy/pull/11296>`__: DOC: special: add to docstrings of Bessel zeros and derivatives
739* `#11297 <https://github.com/scipy/scipy/pull/11297>`__: DOC: special: add parameters/returns sections for Bessel integrals
740* `#11300 <https://github.com/scipy/scipy/pull/11300>`__: MAINT: Update vendored uarray version
741* `#11301 <https://github.com/scipy/scipy/pull/11301>`__: CI: azure conditions should require succeeded()
742* `#11302 <https://github.com/scipy/scipy/pull/11302>`__: ENH: build infrastructure for ILP64 BLAS + ARPACK conversion
743* `#11303 <https://github.com/scipy/scipy/pull/11303>`__: DOC: special: fix typo in \`besselpoly\` docstring
744* `#11304 <https://github.com/scipy/scipy/pull/11304>`__: ENH: MAINT: Rewrite of eigh() and relevant wrappers
745* `#11306 <https://github.com/scipy/scipy/pull/11306>`__: TST: skip test_aligned_mem linalg test that is crashing on ppcle64
746* `#11307 <https://github.com/scipy/scipy/pull/11307>`__: MAINT: Fix typo 'solutuion' -> 'solution'
747* `#11308 <https://github.com/scipy/scipy/pull/11308>`__: ENH: do not create 1d array out of a scalar
748* `#11310 <https://github.com/scipy/scipy/pull/11310>`__: MAINT: clean up object array creation, scalar/1d confusion
749* `#11311 <https://github.com/scipy/scipy/pull/11311>`__: DOC: Specify custom callable option for metric in cluster.hierarchy.fclusterdata
750* `#11316 <https://github.com/scipy/scipy/pull/11316>`__: BUG: special: fix behavior for \`rgamma\` zeros
751* `#11317 <https://github.com/scipy/scipy/pull/11317>`__: BUG: fix floating-point literal comparisons under C99
752* `#11318 <https://github.com/scipy/scipy/pull/11318>`__: TST: optimize: mark two linprog tests for skipping
753* `#11320 <https://github.com/scipy/scipy/pull/11320>`__: BUG: Include \`int64_t\` declaration to \`rectangular_lsap.cpp\`
754* `#11330 <https://github.com/scipy/scipy/pull/11330>`__: MAINT: Update vendored pypocketfft version
755* `#11333 <https://github.com/scipy/scipy/pull/11333>`__: BUG: directed_hausdorff subset fix
756* `#11335 <https://github.com/scipy/scipy/pull/11335>`__: [ENH] sparse: Loosen check for sparse outer indexing fast path
757* `#11337 <https://github.com/scipy/scipy/pull/11337>`__: Undefined name 'e' in pavement.py
758* `#11338 <https://github.com/scipy/scipy/pull/11338>`__: scipyoptdoc.py: Remove unused variable 'sixu'
759* `#11340 <https://github.com/scipy/scipy/pull/11340>`__: xrange() was removed in Python 3 in favor of range()
760* `#11342 <https://github.com/scipy/scipy/pull/11342>`__: range() was removed in Py3 in _binned_statistic.py
761* `#11343 <https://github.com/scipy/scipy/pull/11343>`__: BUG: constants: fix 'exact' values table
762* `#11347 <https://github.com/scipy/scipy/pull/11347>`__: ENH: add input validation function and apply it to needed functions
763* `#11348 <https://github.com/scipy/scipy/pull/11348>`__: MAINT: remove six.string_types usages
764* `#11349 <https://github.com/scipy/scipy/pull/11349>`__: MAINT: minor doc fix _minimize_trustregion_constr
765* `#11353 <https://github.com/scipy/scipy/pull/11353>`__: MAINT: py3 remove various six usages
766* `#11358 <https://github.com/scipy/scipy/pull/11358>`__: ENH: optimize: Use CSR format instead of LIL for speed
767* `#11362 <https://github.com/scipy/scipy/pull/11362>`__: MAINT: sys.version_info >= 3.5
768* `#11364 <https://github.com/scipy/scipy/pull/11364>`__: ENH: cache square of sums for f_oneway
769* `#11368 <https://github.com/scipy/scipy/pull/11368>`__: ENH: add optional argument, "include_nyquist", for freqz()
770* `#11372 <https://github.com/scipy/scipy/pull/11372>`__: BENCH: optimize: added linprog presolve benchmarks
771* `#11376 <https://github.com/scipy/scipy/pull/11376>`__: ENH: Add wrapper for ?gttrf/?gttrs
772* `#11377 <https://github.com/scipy/scipy/pull/11377>`__: MAINT: Remove Python 2 code from tools/authors.py
773* `#11378 <https://github.com/scipy/scipy/pull/11378>`__: ENH (WIP): Python wrapper for ?tbtrs
774* `#11379 <https://github.com/scipy/scipy/pull/11379>`__: MAINT: Remove six.with_metaclass from benchmarks/cython_special.py
775* `#11380 <https://github.com/scipy/scipy/pull/11380>`__: BUG: sparse/isolve: bicg and qmr don't treat x0 correctly
776* `#11382 <https://github.com/scipy/scipy/pull/11382>`__: MAINT: remove error throw in binned_statistic_dd() on non-finite...
777* `#11383 <https://github.com/scipy/scipy/pull/11383>`__: MAINT: _lib: remove py2 compat shims in getargspec
778* `#11384 <https://github.com/scipy/scipy/pull/11384>`__: MAINT: Use numpy scalar types directly
779* `#11385 <https://github.com/scipy/scipy/pull/11385>`__: ENH: special: add spherical Bessel functions to \`cython_special\`
780* `#11389 <https://github.com/scipy/scipy/pull/11389>`__: MAINT: line.startswith shouldn't be bytes
781* `#11393 <https://github.com/scipy/scipy/pull/11393>`__: ENH: Speed up truncnorm's ppf()and rvs() methods
782* `#11394 <https://github.com/scipy/scipy/pull/11394>`__: MAINT: Remove self._size (and self._random_state) from stats...
783* `#11395 <https://github.com/scipy/scipy/pull/11395>`__: correction in error message (%d->%g format)
784* `#11396 <https://github.com/scipy/scipy/pull/11396>`__: DOC: revert gh10540, removing mtrand
785* `#11397 <https://github.com/scipy/scipy/pull/11397>`__: MAINT: differential_evolution accepts np.random.Generator
786* `#11402 <https://github.com/scipy/scipy/pull/11402>`__: ENH: stats can use np.random.Generator
787* `#11404 <https://github.com/scipy/scipy/pull/11404>`__: ENH: add docstring of butter() for transfer function syntax problem
788* `#11405 <https://github.com/scipy/scipy/pull/11405>`__: DOC: Fix "see also" for SmoothBivariateSpline
789* `#11408 <https://github.com/scipy/scipy/pull/11408>`__: ENH: Add a \`plan\` argument to FFT functions in \`scipy.fft\`
790* `#11411 <https://github.com/scipy/scipy/pull/11411>`__: MAINT: check minimize duplicate evaluations
791* `#11418 <https://github.com/scipy/scipy/pull/11418>`__: ENH: Linalg: Python wrapper for ?geqrfp
792* `#11419 <https://github.com/scipy/scipy/pull/11419>`__: TST: Python 3.7 mac OS gcc multibuild fix
793* `#11423 <https://github.com/scipy/scipy/pull/11423>`__: ENH: Add tool to lint diffs
794* `#11425 <https://github.com/scipy/scipy/pull/11425>`__: FIX: _array_newton should preserve complex inputs
795* `#11426 <https://github.com/scipy/scipy/pull/11426>`__: MAINT: licence for global optimization benchmarks
796* `#11431 <https://github.com/scipy/scipy/pull/11431>`__: Make median_absolute_deviation scale argument aligned w/iqr
797* `#11432 <https://github.com/scipy/scipy/pull/11432>`__: Fix error message typo
798* `#11433 <https://github.com/scipy/scipy/pull/11433>`__: DOC: Remove L from longs
799* `#11434 <https://github.com/scipy/scipy/pull/11434>`__: MAINT: Python3 improvements to refguide_check.py
800* `#11435 <https://github.com/scipy/scipy/pull/11435>`__: DOC: Update runtest --parallel help
801* `#11436 <https://github.com/scipy/scipy/pull/11436>`__: MAINT: Remove checks for sys.version < 3.5
802* `#11437 <https://github.com/scipy/scipy/pull/11437>`__: DOC: Fix documentation issue
803* `#11439 <https://github.com/scipy/scipy/pull/11439>`__: Support path objects (PEP 519) in mmio functions
804* `#11440 <https://github.com/scipy/scipy/pull/11440>`__: correct bounds pass in run_dualannealing for benchmarks/optimize.py
805* `#11443 <https://github.com/scipy/scipy/pull/11443>`__: BENCH: optimize_linprog remove ImportError exception
806* `#11453 <https://github.com/scipy/scipy/pull/11453>`__: BUG: sparse: convert csc/csr indices to int64 as needed
807* `#11454 <https://github.com/scipy/scipy/pull/11454>`__: DOC: Remove caveat on \`maximum_bipartite_matching\`
808* `#11455 <https://github.com/scipy/scipy/pull/11455>`__: BUG: Fix _lib._util.getargspec_no_self lack of KEYWORD_ONLY support.
809* `#11456 <https://github.com/scipy/scipy/pull/11456>`__: Implementation of khatri_rao product
810* `#11459 <https://github.com/scipy/scipy/pull/11459>`__: BUG: fix augmentation being broken in maximum_bipartite_matching
811* `#11461 <https://github.com/scipy/scipy/pull/11461>`__: MAINT: minor spelling corrections in comments in SciPy.sparse.linalg.arpack
812* `#11467 <https://github.com/scipy/scipy/pull/11467>`__: [MRG] Make result data type of KDE evaluation like in the input...
813* `#11469 <https://github.com/scipy/scipy/pull/11469>`__: Update integrate.quad documentation
814* `#11472 <https://github.com/scipy/scipy/pull/11472>`__: Fixed result typo
815* `#11476 <https://github.com/scipy/scipy/pull/11476>`__: DOC: stats: Copy-edit the anderson docstring.
816* `#11478 <https://github.com/scipy/scipy/pull/11478>`__: ENH: avoid unnecessary array copies in matrix product
817* `#11481 <https://github.com/scipy/scipy/pull/11481>`__: BUG: Make special.hyperu return nan if any argument is nan
818* `#11483 <https://github.com/scipy/scipy/pull/11483>`__: BUG: Fixed \`_kpp\` initialization on \`scipy.cluster.vq\`, closing...
819* `#11485 <https://github.com/scipy/scipy/pull/11485>`__: ENH: Update docstring of class KrylovJacobian to fix #2744
820* `#11486 <https://github.com/scipy/scipy/pull/11486>`__: BUG: make special.eval_hermite return nan if second argument...
821* `#11487 <https://github.com/scipy/scipy/pull/11487>`__: ENH: improve docstring of correlate and correlate2d to fix #1968
822* `#11488 <https://github.com/scipy/scipy/pull/11488>`__: FIX: change "func -> fun" of scipy.optimize _root.py to solve...
823* `#11489 <https://github.com/scipy/scipy/pull/11489>`__: BUG: fixes typo introduced in PR #11253 in stats.mstats.kendalltau()
824* `#11490 <https://github.com/scipy/scipy/pull/11490>`__: DOC: fix typo in scipy/io/matlab/mio4.py
825* `#11495 <https://github.com/scipy/scipy/pull/11495>`__: MAINT: refactor slsqp to fix issue in callback function
826* `#11498 <https://github.com/scipy/scipy/pull/11498>`__: [DOC] mention graph cuts in maximum flow docstring
827* `#11499 <https://github.com/scipy/scipy/pull/11499>`__: DOC: Improve documentation of scipy.signal.signaltools.wiener
828* `#11506 <https://github.com/scipy/scipy/pull/11506>`__: DOC: Fix typo in documentation of scipy.stats.morestats
829* `#11508 <https://github.com/scipy/scipy/pull/11508>`__: ENH: avoid copy on sparse __init__ when dtype is given
830* `#11509 <https://github.com/scipy/scipy/pull/11509>`__: ENH: avoid unnecessary array copies in matrix product (again)
831* `#11510 <https://github.com/scipy/scipy/pull/11510>`__: [DOC] An ex. for creating arbitrary size tri-diagonal
832* `#11511 <https://github.com/scipy/scipy/pull/11511>`__: TST: pin numba for Travis/sparse
833* `#11513 <https://github.com/scipy/scipy/pull/11513>`__: TST: disable NumPy cache dir ppc64le
834* `#11514 <https://github.com/scipy/scipy/pull/11514>`__: BUG: make special.eval_genlaguerre return nan if passed nan
835* `#11517 <https://github.com/scipy/scipy/pull/11517>`__: ENH: improve sparse.lil.tocsr performance
836* `#11519 <https://github.com/scipy/scipy/pull/11519>`__: Fix fresnel documentation
837* `#11520 <https://github.com/scipy/scipy/pull/11520>`__: BUG: make special.eval_gegenbauer return nan if passed nan
838* `#11524 <https://github.com/scipy/scipy/pull/11524>`__: ENH: Cosine Sine Decomposition
839* `#11526 <https://github.com/scipy/scipy/pull/11526>`__: BUG: fix SLSQP max iteration setting to fix #4921
840* `#11527 <https://github.com/scipy/scipy/pull/11527>`__: ENH: improve docstring of weibull_min_gen and weibull_max_gen...
841* `#11530 <https://github.com/scipy/scipy/pull/11530>`__: MAINT: Removed 3 unused imports, 3 unused assignments from ndimage.
842* `#11531 <https://github.com/scipy/scipy/pull/11531>`__: DOC: fix typos in bdtr and bdtrc from gh PR 11045
843* `#11532 <https://github.com/scipy/scipy/pull/11532>`__: MAINT: Fixed several unused imports and unused assignments from...
844* `#11533 <https://github.com/scipy/scipy/pull/11533>`__: MAINT: Fixed about 100 unused imports, unused assignment warnings...
845* `#11534 <https://github.com/scipy/scipy/pull/11534>`__: FIX: Allow non-native byte order inputs to scipy.fft
846* `#11535 <https://github.com/scipy/scipy/pull/11535>`__: MAINT: Fixed several unused imports in _lib.
847* `#11536 <https://github.com/scipy/scipy/pull/11536>`__: MAINT: Fixed several unused imports and unused assignments in...
848* `#11537 <https://github.com/scipy/scipy/pull/11537>`__: MAINT: Removed an unused import in scipy/constants.
849* `#11538 <https://github.com/scipy/scipy/pull/11538>`__: MAINT: Fixed several unused imports in scipy/fft.
850* `#11539 <https://github.com/scipy/scipy/pull/11539>`__: MAINT: Fixed several unused imports and unused assignments in...
851* `#11540 <https://github.com/scipy/scipy/pull/11540>`__: MAINT: Fixed two unused imports in scipy/misc.
852* `#11541 <https://github.com/scipy/scipy/pull/11541>`__: MAINT: Fixed several unused imports and unused assignments in...
853* `#11542 <https://github.com/scipy/scipy/pull/11542>`__: MAINT: Fixed an unused import in scipy/odr.
854* `#11543 <https://github.com/scipy/scipy/pull/11543>`__: MAINT: Fixed several unused imports and unused assignments in...
855* `#11544 <https://github.com/scipy/scipy/pull/11544>`__: MAINT: Fixed unused imports and unused assignments in scipy/integrate.
856* `#11545 <https://github.com/scipy/scipy/pull/11545>`__: MAINT: Removed unused imports and fixed unused assignments in...
857* `#11546 <https://github.com/scipy/scipy/pull/11546>`__: MAINT: Removed unused imports; fixed unused assignments in scipy/signal.
858* `#11547 <https://github.com/scipy/scipy/pull/11547>`__: MAINT: Removed unused imports; fixed unused assignments in scipy/spatial
859* `#11548 <https://github.com/scipy/scipy/pull/11548>`__: MAINT: Removed unused imports; fixed unused assignments in scipy.sparse.
860* `#11549 <https://github.com/scipy/scipy/pull/11549>`__: MAINT: Replace xrange with range
861* `#11560 <https://github.com/scipy/scipy/pull/11560>`__: MAINT: stats: remove an _argcheck call
862* `#11573 <https://github.com/scipy/scipy/pull/11573>`__: MAINT: Removed unused imports; fixed unused assignments in scipy/stats.
863* `#11574 <https://github.com/scipy/scipy/pull/11574>`__: MAINT: Small change to \`optimize.nnls\` error messages.
864* `#11575 <https://github.com/scipy/scipy/pull/11575>`__: MAINT: Update sytrd/hetrd tests
865* `#11582 <https://github.com/scipy/scipy/pull/11582>`__: MAINT: fix typo in quadpack.py closes #11448
866* `#11585 <https://github.com/scipy/scipy/pull/11585>`__: TST: add openblas_support.py
867* `#11587 <https://github.com/scipy/scipy/pull/11587>`__: BUG: Differential evolution with LinearConstraint with sparse...
868* `#11588 <https://github.com/scipy/scipy/pull/11588>`__: MAINT: Fully display problem size in lsmr/lsqr.
869* `#11589 <https://github.com/scipy/scipy/pull/11589>`__: MAINT: Remove Python 2 workarounds
870* `#11590 <https://github.com/scipy/scipy/pull/11590>`__: MAINT: Remove Python2 module init
871* `#11605 <https://github.com/scipy/scipy/pull/11605>`__: Standardization of bounds in _linprog_util.py
872* `#11608 <https://github.com/scipy/scipy/pull/11608>`__: BUG: fix use of is in DE callback
873* `#11614 <https://github.com/scipy/scipy/pull/11614>`__: TST, MAINT: TestCtypesQuad skip with pytest
874* `#11619 <https://github.com/scipy/scipy/pull/11619>`__: ENH: add nan_policy argument and functionality to stats.mstats.winsorize
875* `#11621 <https://github.com/scipy/scipy/pull/11621>`__: MAINT: Cleanup uses of PY_VERSION_HEX, NPY_PY3K in ndimage
876* `#11622 <https://github.com/scipy/scipy/pull/11622>`__: MAINT: Cleanup uses of PY_VERSION_HEX, NPY_PY3K in sparse
877* `#11623 <https://github.com/scipy/scipy/pull/11623>`__: MAINT: Remove unnecessary 'from __future__ import ...' statements
878* `#11626 <https://github.com/scipy/scipy/pull/11626>`__: MAINT: Cleanup uses of PY_VERSION_HEX
879* `#11627 <https://github.com/scipy/scipy/pull/11627>`__: ENH: add analytic formula for normal moments
880* `#11628 <https://github.com/scipy/scipy/pull/11628>`__: MAINT, TST: adjust azure for matplotlib release
881* `#11631 <https://github.com/scipy/scipy/pull/11631>`__: Revert to old behaviour for constant cost matrices in \`linear_sum_assignment\`
882* `#11632 <https://github.com/scipy/scipy/pull/11632>`__: MAINT: Define ARRAY_ANYORDER with DEF instead of cdef
883* `#11639 <https://github.com/scipy/scipy/pull/11639>`__: BUG: interpolate/interp1d: fail gracefully on all-nan inputs
884* `#11640 <https://github.com/scipy/scipy/pull/11640>`__: MAINT: Fix BLAS3 trmm wrapper for "side" arg
885* `#11642 <https://github.com/scipy/scipy/pull/11642>`__: TST, MAINT: remove dead code in Travis CI
886* `#11643 <https://github.com/scipy/scipy/pull/11643>`__: MAINT: fix conversion in binom_test
887* `#11645 <https://github.com/scipy/scipy/pull/11645>`__: MAINT: Assorted clean up.
888* `#11646 <https://github.com/scipy/scipy/pull/11646>`__: MAINT: Remove unnecessary 'from __future__ import ...' statements
889* `#11647 <https://github.com/scipy/scipy/pull/11647>`__: DOC: document return_all arguments
890* `#11648 <https://github.com/scipy/scipy/pull/11648>`__: Perform geometric slerp in quaternion space
891* `#11651 <https://github.com/scipy/scipy/pull/11651>`__: DOC: Update paper URL in lambertw documentation
892* `#11653 <https://github.com/scipy/scipy/pull/11653>`__: PERF: Switch to C++ STL std::nth_element
893* `#11655 <https://github.com/scipy/scipy/pull/11655>`__: MAINT: Remove Python2 cStringStream
894* `#11657 <https://github.com/scipy/scipy/pull/11657>`__: ENH: Add wrapper for ?pttrf/?pttrs
895* `#11664 <https://github.com/scipy/scipy/pull/11664>`__: ENH: Add wrapper for ?gejsv
896* `#11665 <https://github.com/scipy/scipy/pull/11665>`__: ENH: Add wrapper for ?pteqr
897* `#11667 <https://github.com/scipy/scipy/pull/11667>`__: BUG: Non-central Fisher distribution (fix nan-values when nc=0)
898* `#11668 <https://github.com/scipy/scipy/pull/11668>`__: ENH: Add wrapper for ?gtsvx
899* `#11671 <https://github.com/scipy/scipy/pull/11671>`__: TST, CI: restore Azure temporarily
900* `#11672 <https://github.com/scipy/scipy/pull/11672>`__: Add warning to medfilt when array size < kernel_size
901* `#11674 <https://github.com/scipy/scipy/pull/11674>`__: TST: bump test precision for two np.dot related linalg tests.
902* `#11675 <https://github.com/scipy/scipy/pull/11675>`__: MAINT: pycodestyle clean-up
903* `#11677 <https://github.com/scipy/scipy/pull/11677>`__: ENH: Add wrapper for ?ptsvx
904* `#11679 <https://github.com/scipy/scipy/pull/11679>`__: BENCH: cKDTree benchmarks added: balanced/unbalanced tree (related...
905* `#11680 <https://github.com/scipy/scipy/pull/11680>`__: MAINT: rng_integers allows RandomState.randint or Generator.integers
906* `#11683 <https://github.com/scipy/scipy/pull/11683>`__: BUG: fix mode='mirror' on length 1 axes
907* `#11684 <https://github.com/scipy/scipy/pull/11684>`__: BUG: fix scipy.special.voigt_profile
908* `#11687 <https://github.com/scipy/scipy/pull/11687>`__: MAINT: sparse.linalg: avoid importing from \`np.core\`
909* `#11688 <https://github.com/scipy/scipy/pull/11688>`__: ENH: mypy: get specific about ignoring missing imports
910* `#11690 <https://github.com/scipy/scipy/pull/11690>`__: MAINT: mypy: fix errors about incompatible types in lists
911* `#11692 <https://github.com/scipy/scipy/pull/11692>`__: MAINT: mypy: fix remaining type errors
912* `#11694 <https://github.com/scipy/scipy/pull/11694>`__: TST, MAINT: bump to OpenBLAS 0.3.9 stable, raise tol for Win...
913* `#11697 <https://github.com/scipy/scipy/pull/11697>`__: DOC: fix pdf of norminvgauss in scipy.stats
914* `#11701 <https://github.com/scipy/scipy/pull/11701>`__: MAINT: special: add rudimentary types for \`_ufuncs\` extension...
915* `#11702 <https://github.com/scipy/scipy/pull/11702>`__: BUG: Fixed a post-merge bug for eigh()
916* `#11703 <https://github.com/scipy/scipy/pull/11703>`__: Improves docstring with consistent L2-norm
917* `#11705 <https://github.com/scipy/scipy/pull/11705>`__: DOC: Slerp the SphericalVoronoi docstring
918* `#11706 <https://github.com/scipy/scipy/pull/11706>`__: ENH: mypy: add \`--mypy\` option to \`runtests.py\`
919* `#11710 <https://github.com/scipy/scipy/pull/11710>`__: ENH: Modified stats.kstest() to use the exact stats.kstwo.sf()...
920* `#11715 <https://github.com/scipy/scipy/pull/11715>`__: DOC: add .. versionadded:: to as_matrix/from_matrix in spatial/transf921* `#11716 <https://github.com/scipy/scipy/pull/11716>`__: BENCH: fix benchmark imports for \`\`optimize_linprog.py\`\`
922* `#11721 <https://github.com/scipy/scipy/pull/11721>`__: MAINT: io: Remove now-unnecessary \`# type: ignore\`
923* `#11722 <https://github.com/scipy/scipy/pull/11722>`__: MAINT: mypy: remove mpmath from the ratchet
924* `#11726 <https://github.com/scipy/scipy/pull/11726>`__: Handle constant input for scipy.stats.f_oneway
925* `#11729 <https://github.com/scipy/scipy/pull/11729>`__: BENCH: optimize: added infeasible benchmarks for linprog
926* `#11731 <https://github.com/scipy/scipy/pull/11731>`__: fix inaccurate information about Mac OS compiler (#11696)
927* `#11733 <https://github.com/scipy/scipy/pull/11733>`__: Fix inaccurate docstring example of HalfspaceIntersection
928* `#11734 <https://github.com/scipy/scipy/pull/11734>`__: Doc: fix inaccurate docstring of SmoothBivariateSpline.
929* `#11735 <https://github.com/scipy/scipy/pull/11735>`__: Bug: stats: fix wrong shape from median_absolute_deviation for...
930* `#11736 <https://github.com/scipy/scipy/pull/11736>`__: ENH: add input validations and its tests for FITPACK in fitpack2.py
931* `#11737 <https://github.com/scipy/scipy/pull/11737>`__: BUG: Prevent crashes due to MKL bug in ?heevr
932* `#11739 <https://github.com/scipy/scipy/pull/11739>`__: MAINT: special: add type stubs for \`_test_round.pyx\`
933* `#11740 <https://github.com/scipy/scipy/pull/11740>`__: MAINT: special: remove unused specfun f2py wrappers
934* `#11741 <https://github.com/scipy/scipy/pull/11741>`__: BUG: fix small tolerances handling for minpack and add a test.
935* `#11743 <https://github.com/scipy/scipy/pull/11743>`__: Doc: fix docstring of rfft, rfft2, rfftn, irfft, irfft2, irfftn...
936* `#11744 <https://github.com/scipy/scipy/pull/11744>`__: MAINT: Remove unused py3k.h code
937* `#11745 <https://github.com/scipy/scipy/pull/11745>`__: DOC: stats: Clean up ncf documentation.
938* `#11748 <https://github.com/scipy/scipy/pull/11748>`__: MAINT: special: type \`cython_special\` as \`Any\`
939* `#11750 <https://github.com/scipy/scipy/pull/11750>`__: MAINT: type hints for \`_spherical_voronoi\`
940* `#11752 <https://github.com/scipy/scipy/pull/11752>`__: DOC: fix docstring of scipy.optimize.least_squares
941* `#11753 <https://github.com/scipy/scipy/pull/11753>`__: ENH: add input validation for dendrogram and a test.
942* `#11755 <https://github.com/scipy/scipy/pull/11755>`__: MAINT: Replace uses of tostring with tobytes
943* `#11757 <https://github.com/scipy/scipy/pull/11757>`__: ENH: improve binned_statistics_2d performance.
944* `#11759 <https://github.com/scipy/scipy/pull/11759>`__: ENH: optimize: add HiGHS methods to linprog
945* `#11760 <https://github.com/scipy/scipy/pull/11760>`__: MAINT: Remove FileStream replaced by GenericStream
946* `#11761 <https://github.com/scipy/scipy/pull/11761>`__: MAINT: Replace npy_3kcompat.h shims
947* `#11765 <https://github.com/scipy/scipy/pull/11765>`__: TST: Speedup test_pascal which is VERY slow on Azure
948* `#11766 <https://github.com/scipy/scipy/pull/11766>`__: TST: speed up differential_evolution L8 test
949* `#11767 <https://github.com/scipy/scipy/pull/11767>`__: Change comment in continuous rv gamma fit function
950* `#11776 <https://github.com/scipy/scipy/pull/11776>`__: Add domain option for resample.
951* `#11784 <https://github.com/scipy/scipy/pull/11784>`__: BUG: Fixed calculation of nonzero elements in scipy.sparse.random
952* `#11786 <https://github.com/scipy/scipy/pull/11786>`__: ENH: stats: add axis keyword argument to scipy.stats.rankdata
953* `#11789 <https://github.com/scipy/scipy/pull/11789>`__: Doc: fix docstring of scipy.spatial.chebyshev
954* `#11792 <https://github.com/scipy/scipy/pull/11792>`__: DOC: dev: add guidelines for developing public Cython APIs
955* `#11794 <https://github.com/scipy/scipy/pull/11794>`__: MAINT: add comments explaining a problem in cython_optimize organization
956* `#11796 <https://github.com/scipy/scipy/pull/11796>`__: DOC: add a note about precision losing in csgraph.minimum_spanning_tree...
957* `#11797 <https://github.com/scipy/scipy/pull/11797>`__: ENH: Allow negative \`axis\` in \`interpolate.BSpline\`. Also...
958* `#11798 <https://github.com/scipy/scipy/pull/11798>`__: Add simplify_cells parameter to scipy.io.loadmat
959* `#11801 <https://github.com/scipy/scipy/pull/11801>`__: MAINT, DOC: minor changes of ratio-of-uniforms in scipy.stats
960* `#11802 <https://github.com/scipy/scipy/pull/11802>`__: BUG: fix scipy.odr to handle multidimensional independent and...
961* `#11803 <https://github.com/scipy/scipy/pull/11803>`__: scipy.stats.trapz: Use analytic formulas for stats and entropy.
962* `#11808 <https://github.com/scipy/scipy/pull/11808>`__: DOC: add Examples in the scipy.interpolate.interpn docstring.
963* `#11809 <https://github.com/scipy/scipy/pull/11809>`__: Duplicate entries are added together in csr_matrix constructor
964* `#11813 <https://github.com/scipy/scipy/pull/11813>`__: MAINT: bump pyflakes to version 2.1.1
965* `#11814 <https://github.com/scipy/scipy/pull/11814>`__: BUG: scipy.sparse.csr doctest failing with incorrect output value
966* `#11817 <https://github.com/scipy/scipy/pull/11817>`__: DOC: add Examples in the scipy.optimize.leastsq docstring
967* `#11820 <https://github.com/scipy/scipy/pull/11820>`__: ENH: Raise an error on incorrect bounds format in optimize.fmin_l_bfgs_b
968* `#11822 <https://github.com/scipy/scipy/pull/11822>`__: CI: add github actions for macOS
969* `#11824 <https://github.com/scipy/scipy/pull/11824>`__: DOC: add Examples in scipy.optimize.line_search docstring (line_search_wolfe2)
970* `#11830 <https://github.com/scipy/scipy/pull/11830>`__: TST: Always use fork for multiprocessing in fft tests
971* `#11831 <https://github.com/scipy/scipy/pull/11831>`__: DOC: add Examples and Returns in scipy.misc.central_diff_weights...
972* `#11832 <https://github.com/scipy/scipy/pull/11832>`__: DOC: stats: Some small corrections to a couple docstrings.
973* `#11833 <https://github.com/scipy/scipy/pull/11833>`__: BUG: Fix compiler_name when there are paths used in flags
974* `#11836 <https://github.com/scipy/scipy/pull/11836>`__: MAINT: re-introduce multiprocessing tests on Python3.8
975* `#11837 <https://github.com/scipy/scipy/pull/11837>`__: Doc: add Examples in scipy.optimize.fsolve docstring
976* `#11838 <https://github.com/scipy/scipy/pull/11838>`__: Doc: add Examples in scipy.sparse.linalg.minres docstring
977* `#11840 <https://github.com/scipy/scipy/pull/11840>`__: BUG: sparse.linalg: fix overflow in expm intermediate computation
978* `#11842 <https://github.com/scipy/scipy/pull/11842>`__: BLD: fix build with gfortran 10
979* `#11843 <https://github.com/scipy/scipy/pull/11843>`__: MAINT: Simplify floats in constants.py
980* `#11847 <https://github.com/scipy/scipy/pull/11847>`__: DOC: add a tutorial of scipy.optimize.linprog
981* `#11849 <https://github.com/scipy/scipy/pull/11849>`__: ENH: speed up geninvgauss by using cython
982* `#11852 <https://github.com/scipy/scipy/pull/11852>`__: CI: remove osx from travisCI
983* `#11857 <https://github.com/scipy/scipy/pull/11857>`__: BUG: Change parameter fc of gausspulse to float.
984* `#11861 <https://github.com/scipy/scipy/pull/11861>`__: order = degree + 1 for splines
985* `#11863 <https://github.com/scipy/scipy/pull/11863>`__: Make g77 ABI wrapper work with gfortran ABI lapack
986* `#11866 <https://github.com/scipy/scipy/pull/11866>`__: MAINT: add type ignores to sympy and matplotlib imports
987* `#11867 <https://github.com/scipy/scipy/pull/11867>`__: CI: Add arm64 in travis-ci
988* `#11869 <https://github.com/scipy/scipy/pull/11869>`__: DOC: signal: Add an example to the lsim2 docstring.
989* `#11870 <https://github.com/scipy/scipy/pull/11870>`__: DOC: signal: Use impulse instead of impulse2 in the impulse example...
990* `#11871 <https://github.com/scipy/scipy/pull/11871>`__: ENH: type ufuncs in special as ufuncs instead of Any
991* `#11872 <https://github.com/scipy/scipy/pull/11872>`__: BUG: avoid recomputing in scipy.optimize.optimize.MemoizeJac
992* `#11873 <https://github.com/scipy/scipy/pull/11873>`__: DOC: signal: Fix ODE in impulse and impulse2 docstrings.
993* `#11874 <https://github.com/scipy/scipy/pull/11874>`__: DOC: add Examples of docstring for scipy.interpolate.approximate_taylor_polynomial
994* `#11878 <https://github.com/scipy/scipy/pull/11878>`__: DOC: fixed a typo under scipy/integrate/quadrature.py
995* `#11879 <https://github.com/scipy/scipy/pull/11879>`__: BUG: Fix index arrays overflow in sparse.kron
996* `#11880 <https://github.com/scipy/scipy/pull/11880>`__: DOC: stats: Add Examples for bartlett, fligner, levene.
997* `#11881 <https://github.com/scipy/scipy/pull/11881>`__: MAINT: normalise numpy-->np in optimize.py
998* `#11882 <https://github.com/scipy/scipy/pull/11882>`__: DOC: add Examples for scipy.io.readsav docstring.
999* `#11883 <https://github.com/scipy/scipy/pull/11883>`__: DOC: add Returns and Examples for scipy.ndimage.correlate() docstring
1000* `#11885 <https://github.com/scipy/scipy/pull/11885>`__: BUG: stats: Handle multidimensional arrays in f_oneway, and more.
1001* `#11889 <https://github.com/scipy/scipy/pull/11889>`__: DOC: signal: Unify lsim and lsim2 examples.
1002* `#11896 <https://github.com/scipy/scipy/pull/11896>`__: BUG: stats: Fix handling of size 0 inputs for ttest_rel and ttest_ind.
1003* `#11897 <https://github.com/scipy/scipy/pull/11897>`__: DOC: Remove misleading default values from fit method
1004* `#11898 <https://github.com/scipy/scipy/pull/11898>`__: MAINT: LinearVectorFunction.J is ndarray closes #11886
1005* `#11902 <https://github.com/scipy/scipy/pull/11902>`__: BUG: linalg: test_heequb failure
1006* `#11904 <https://github.com/scipy/scipy/pull/11904>`__: fix real-to-real transforms for complex inputs and overwrite_x=True
1007* `#11906 <https://github.com/scipy/scipy/pull/11906>`__: DOC: stats: fix error caused by trapz docstring
1008* `#11907 <https://github.com/scipy/scipy/pull/11907>`__: BUG: stats: fixed SEGFAULT from Issue #9710
1009* `#11912 <https://github.com/scipy/scipy/pull/11912>`__: ENH: Respect matplotlib color palette with hierarchy/dendrogram.
1010* `#11914 <https://github.com/scipy/scipy/pull/11914>`__: DOC: refine doc for spatial.distance.squareform
1011* `#11915 <https://github.com/scipy/scipy/pull/11915>`__: ENH: Ndim linear operator
1012* `#11919 <https://github.com/scipy/scipy/pull/11919>`__: ENH: expose "window_size" parameter in find_peaks_cwt()
1013* `#11920 <https://github.com/scipy/scipy/pull/11920>`__: DOC: explain M, diffev
1014* `#11923 <https://github.com/scipy/scipy/pull/11923>`__: CI: macOS install swig closes #11922
1015* `#11924 <https://github.com/scipy/scipy/pull/11924>`__: DOC: add Examples for scipy.optimize.bracket() docstring
1016* `#11930 <https://github.com/scipy/scipy/pull/11930>`__: DOC: add Examples and clean up for signal.qspline1d and signal.qspline_eval...
1017* `#11931 <https://github.com/scipy/scipy/pull/11931>`__: DOC: add Examples for sparse.linalg.bicg docstring.
1018* `#11933 <https://github.com/scipy/scipy/pull/11933>`__: DOC: Add original reference for Yao-Liu objective functions
1019* `#11934 <https://github.com/scipy/scipy/pull/11934>`__: DOC, MAINT: mailmap update
1020* `#11935 <https://github.com/scipy/scipy/pull/11935>`__: DOC: make scipy.stats.mode documentation reflect that the function...
1021* `#11936 <https://github.com/scipy/scipy/pull/11936>`__: ENH: special: add type stubs for \`orthogonal.py\`
1022* `#11937 <https://github.com/scipy/scipy/pull/11937>`__: DOC: Add docstring examples to fft2, ifft2, io.savemat
1023* `#11938 <https://github.com/scipy/scipy/pull/11938>`__: MAINT: add helper function for deprecating Cython API functions
1024* `#11942 <https://github.com/scipy/scipy/pull/11942>`__: MAINT: ignore conditional import in _lib/_util
1025* `#11943 <https://github.com/scipy/scipy/pull/11943>`__: MAINT: special: add types for geterr/seterr/errstate
1026* `#11946 <https://github.com/scipy/scipy/pull/11946>`__: MAINT: add py.typed marker
1027* `#11950 <https://github.com/scipy/scipy/pull/11950>`__: TST:MAINT: separated and stabilized heequb tests
1028* `#11952 <https://github.com/scipy/scipy/pull/11952>`__: DOC: update toolchain roadmap for py38, C99, C++11/14
1029* `#11957 <https://github.com/scipy/scipy/pull/11957>`__: MAINT: Use np.errstate context manager instead of np.seterr.
1030* `#11958 <https://github.com/scipy/scipy/pull/11958>`__: MAINT: interpolate: Remove some trailing spaces.
1031* `#11960 <https://github.com/scipy/scipy/pull/11960>`__: MAINT: Cleanup Python2 compatibility code
1032* `#11961 <https://github.com/scipy/scipy/pull/11961>`__: MAINT: Remove numpy/npy_3kcompat.h from _superluobject.c
1033* `#11962 <https://github.com/scipy/scipy/pull/11962>`__: DOC: Fix type of \`codes\` in docstring of \`_vq._vq()\`
1034* `#11964 <https://github.com/scipy/scipy/pull/11964>`__: MAINT: Cleanup unused IS_PYPY
1035* `#11969 <https://github.com/scipy/scipy/pull/11969>`__: DOC: add Examples and fix docstring for special.airye
1036* `#11970 <https://github.com/scipy/scipy/pull/11970>`__: BUG: sparse: 'diagonal' of sparse matrices fixed to match numpy's...
1037* `#11974 <https://github.com/scipy/scipy/pull/11974>`__: BUG: Reshape oaconvolve output even when no axes are convolved
1038* `#11976 <https://github.com/scipy/scipy/pull/11976>`__: MAINT: add logo for github actions
1039* `#11977 <https://github.com/scipy/scipy/pull/11977>`__: CI: test bleeding edge Python
1040* `#11979 <https://github.com/scipy/scipy/pull/11979>`__: DOC: add Examples for stats.ranksums() docstring.
1041* `#11982 <https://github.com/scipy/scipy/pull/11982>`__: Fix KMeans++ initialisation slowness
1042* `#11983 <https://github.com/scipy/scipy/pull/11983>`__: DOC: add Examples for stats.mstats.argstoarray() docstring.
1043* `#11986 <https://github.com/scipy/scipy/pull/11986>`__: Avoid bugs in ndimage when the output and input arrays overlap...
1044* `#11988 <https://github.com/scipy/scipy/pull/11988>`__: ENH: Override fit method of Laplace distribution with Maximum...
1045* `#11993 <https://github.com/scipy/scipy/pull/11993>`__: TST, CI: Azure Windows path fixups
1046* `#11995 <https://github.com/scipy/scipy/pull/11995>`__: MAINT, CI: remove custom mingw Azure
1047* `#11996 <https://github.com/scipy/scipy/pull/11996>`__: DOC: add Examples and fix pep warning for fft.set_global_backend...
1048* `#11997 <https://github.com/scipy/scipy/pull/11997>`__: MAINT, CI: Azure OpenBLAS simplify
1049* `#11998 <https://github.com/scipy/scipy/pull/11998>`__: BENCH: Run against current HEAD instead of master
1050* `#12001 <https://github.com/scipy/scipy/pull/12001>`__: ENH: stats: Implement _logpdf for the maxwell distribution.
1051* `#12004 <https://github.com/scipy/scipy/pull/12004>`__: DOC: add examples for integrate.quad_vec() and integrate.quad_explain()
1052* `#12005 <https://github.com/scipy/scipy/pull/12005>`__: MAINT: Use helper functions in ?tbtrs tests
1053* `#12007 <https://github.com/scipy/scipy/pull/12007>`__: MAINT: updated LICENSES_bundled for pybind11 and six
1054* `#12008 <https://github.com/scipy/scipy/pull/12008>`__: DOC: roadmap update
1055* `#12009 <https://github.com/scipy/scipy/pull/12009>`__: ENH: optimize: support 64-bit BLAS in lbfgsb
1056* `#12010 <https://github.com/scipy/scipy/pull/12010>`__: ENH: sparse.linalg: support 64-bit BLAS in isolve
1057* `#12012 <https://github.com/scipy/scipy/pull/12012>`__: DOC: add Examples for interpolate.barycentric_interpolate(),...
1058* `#12013 <https://github.com/scipy/scipy/pull/12013>`__: MAINT: remove last uses of numpy.dual
1059* `#12014 <https://github.com/scipy/scipy/pull/12014>`__: CI: print 10 slowest tests
1060* `#12020 <https://github.com/scipy/scipy/pull/12020>`__: MAINT: Removed handling of circular input in SphericalVoronoi
1061* `#12022 <https://github.com/scipy/scipy/pull/12022>`__: DOC : added default value of absolute_sigma to False in scipy.optimize.curve_fit docs
1062* `#12024 <https://github.com/scipy/scipy/pull/12024>`__: DOC: add Examples for io.hb_read() and io.hb_write()
1063* `#12025 <https://github.com/scipy/scipy/pull/12025>`__: MAINT: Remove numpy/npy_3kcompat.h from nd_image
1064* `#12028 <https://github.com/scipy/scipy/pull/12028>`__: Spelling correction
1065* `#12030 <https://github.com/scipy/scipy/pull/12030>`__: ENH: optimize/_trlib: support ILP64 blas/lapack
1066* `#12036 <https://github.com/scipy/scipy/pull/12036>`__: MAINT: Add some generated C files .gitignore
1067* `#12038 <https://github.com/scipy/scipy/pull/12038>`__: MAINT, CI: Travis rackcdn->conda.org
1068* `#12039 <https://github.com/scipy/scipy/pull/12039>`__: MAINT: signal: Lower the resolution of the plots in the chirp...
1069* `#12040 <https://github.com/scipy/scipy/pull/12040>`__: DOC: add Examples for ndimage.spline_filter1d() and spline_filter()...
1070* `#12044 <https://github.com/scipy/scipy/pull/12044>`__: MAINT: combine apt-get update and apt-get install into one RUN
1071* `#12045 <https://github.com/scipy/scipy/pull/12045>`__: TST: Reduce size of test_diagonal_types to speed up tests
1072* `#12046 <https://github.com/scipy/scipy/pull/12046>`__: MAINT: Remove unused npy_3kcompat.h
1073* `#12047 <https://github.com/scipy/scipy/pull/12047>`__: MAINT: Cython 3.0 compat
1074* `#12050 <https://github.com/scipy/scipy/pull/12050>`__: DOC: add download number badges of PyPI and conda-forge in README.rst
1075* `#12052 <https://github.com/scipy/scipy/pull/12052>`__: DOC: add Examples odr.models.polynomial() and fix odr.odr docstring...
1076* `#12056 <https://github.com/scipy/scipy/pull/12056>`__: ENH: Modifies shapiro to return a named tuple
1077* `#12057 <https://github.com/scipy/scipy/pull/12057>`__: Adding my name into THANKS.txt
1078* `#12060 <https://github.com/scipy/scipy/pull/12060>`__: TST: Reduce number of test_diagonal_types configs
1079* `#12062 <https://github.com/scipy/scipy/pull/12062>`__: TST: Change dec.slow to pytest.mark.slow
1080* `#12068 <https://github.com/scipy/scipy/pull/12068>`__: ENH: Modifies jarque_bera to return a named tuple
1081* `#12070 <https://github.com/scipy/scipy/pull/12070>`__: MAINT, CI: appveyor rack->conda.org
1082* `#12072 <https://github.com/scipy/scipy/pull/12072>`__: TST: filter out factorial(float) deprecation warning
1083* `#12078 <https://github.com/scipy/scipy/pull/12078>`__: TST: Skip test on colab with large memory alloc
1084* `#12079 <https://github.com/scipy/scipy/pull/12079>`__: DOC: Remove Python2 reference from stats tutorial
1085* `#12081 <https://github.com/scipy/scipy/pull/12081>`__: DOC: add Examples docstring for optimize.show_options()
1086* `#12084 <https://github.com/scipy/scipy/pull/12084>`__: BUG: interpolate: fix BarycentricInterpolator with integer input...
1087* `#12089 <https://github.com/scipy/scipy/pull/12089>`__: ENH: spatial/qhull: support ILP64 Lapack
1088* `#12090 <https://github.com/scipy/scipy/pull/12090>`__: ENH: integrate: support ILP64 BLAS in odeint/vode/lsoda
1089* `#12091 <https://github.com/scipy/scipy/pull/12091>`__: ENH: integrate: support ILP64 in quadpack
1090* `#12092 <https://github.com/scipy/scipy/pull/12092>`__: BUG: Fix dropping dt in signal.StateSpace
1091* `#12093 <https://github.com/scipy/scipy/pull/12093>`__: MAINT: Rollback python2.6 workaround
1092* `#12094 <https://github.com/scipy/scipy/pull/12094>`__: MAINT: \`openblas_support\` hash checks
1093* `#12095 <https://github.com/scipy/scipy/pull/12095>`__: MAINT: ndimage: change \`shares_memory\` to \`may_share_memory\`
1094* `#12098 <https://github.com/scipy/scipy/pull/12098>`__: Doc: change 4 model instances of odr to be instances of \`Model\`...
1095* `#12101 <https://github.com/scipy/scipy/pull/12101>`__: Removed more unused imports and assignments.
1096* `#12107 <https://github.com/scipy/scipy/pull/12107>`__: ENH: Area calculation for 2D inputs in SphericalVoronoi
1097* `#12108 <https://github.com/scipy/scipy/pull/12108>`__: MAINT: ensure attributes have correct data type in \`SphericalVoronoi\`
1098* `#12109 <https://github.com/scipy/scipy/pull/12109>`__: degree is not order in splines
1099* `#12110 <https://github.com/scipy/scipy/pull/12110>`__: ENH: More helpful/forgiving io.wavfile errors
1100* `#12117 <https://github.com/scipy/scipy/pull/12117>`__: BUG: fix newline
1101* `#12123 <https://github.com/scipy/scipy/pull/12123>`__: [MAINT] Fix error on PyData/Sparse import.
1102* `#12124 <https://github.com/scipy/scipy/pull/12124>`__: TST: Always test matmul now that Python3.5+ is required
1103* `#12126 <https://github.com/scipy/scipy/pull/12126>`__: TST: Cleanup unused matplotlib code.
1104* `#12127 <https://github.com/scipy/scipy/pull/12127>`__: DOC: update docstrings of signal.cspline2d, qspline2d, sepfir2d
1105* `#12130 <https://github.com/scipy/scipy/pull/12130>`__: MAINT: Fixing broken links with linkchecker
1106* `#12135 <https://github.com/scipy/scipy/pull/12135>`__: ENH: linalg: Add the function convolution_matrix.
1107* `#12136 <https://github.com/scipy/scipy/pull/12136>`__: MAINT: Cleanup np.poly1d hack
1108* `#12137 <https://github.com/scipy/scipy/pull/12137>`__: TST, CI: reproduce wheels 32-bit setup
1109* `#12140 <https://github.com/scipy/scipy/pull/12140>`__: TST: stats: add kstwo, ksone to slow tests.
1110* `#12141 <https://github.com/scipy/scipy/pull/12141>`__: Support 64-bit integer size in Fitpack
1111* `#12151 <https://github.com/scipy/scipy/pull/12151>`__: DOC: Correct Rosenbrock function sum
1112* `#12159 <https://github.com/scipy/scipy/pull/12159>`__: BUG: Fix length calculation in upfirdn
1113* `#12160 <https://github.com/scipy/scipy/pull/12160>`__: BUG: Fix M_PI
1114* `#12168 <https://github.com/scipy/scipy/pull/12168>`__: DOC: add an obsolete version checking javascript to doc release...
1115* `#12171 <https://github.com/scipy/scipy/pull/12171>`__: CI, MAINT: Azure OpenBLAS drive flip
1116* `#12172 <https://github.com/scipy/scipy/pull/12172>`__: ENH: Bounds for the Powell minimization method
1117* `#12175 <https://github.com/scipy/scipy/pull/12175>`__: BLD: support more Fortran compilers for ilp64 and macro expansion...
1118* `#12179 <https://github.com/scipy/scipy/pull/12179>`__: BUG: stats: A few distributions didn't accept lists as arguments.
1119* `#12180 <https://github.com/scipy/scipy/pull/12180>`__: MAINT: removed redundant import in SphericalVoronoi tests
1120* `#12181 <https://github.com/scipy/scipy/pull/12181>`__: DOC: for versionwarning don't use $.getScript
1121* `#12182 <https://github.com/scipy/scipy/pull/12182>`__: MAINT: random sampling on the hypersphere in SphericalVoronoi...
1122* `#12194 <https://github.com/scipy/scipy/pull/12194>`__: MAINT: Module and example cleanups for doc build
1123* `#12202 <https://github.com/scipy/scipy/pull/12202>`__: ENH: tool to DL release wheels from Anaconda
1124* `#12210 <https://github.com/scipy/scipy/pull/12210>`__: Remove py.typed marker (at least for the release)
1125* `#12217 <https://github.com/scipy/scipy/pull/12217>`__: BUG: stats: Fix handling of edge cases in median_abs_deviation.
1126* `#12223 <https://github.com/scipy/scipy/pull/12223>`__: BUG: stats: wilcoxon returned p > 1 for certain inputs.
1127* `#12227 <https://github.com/scipy/scipy/pull/12227>`__: BLD: Set macos min version when building rectangular_lsap
1128* `#12229 <https://github.com/scipy/scipy/pull/12229>`__: MAINT: tools/gh_lists.py: fix http header case sensitivity issue
1129* `#12236 <https://github.com/scipy/scipy/pull/12236>`__: DOC: Fix a couple grammatical mistakes in 1.5.0-notes.rst.
1130* `#12276 <https://github.com/scipy/scipy/pull/12276>`__: TST: skip `test_heequb`, it fails intermittently.
1131* `#12285 <https://github.com/scipy/scipy/pull/12285>`__: CI: split travis arm64 run into two
1132* `#12317 <https://github.com/scipy/scipy/pull/12317>`__: BUG: prevent error accumulation in `Rotation` multiplication
1133* `#12318 <https://github.com/scipy/scipy/pull/12318>`__: BUG: sparse: avoid np.prod overflow in check_shape
1134* `#12319 <https://github.com/scipy/scipy/pull/12319>`__: BUG: Make cobyla threadsafe
1135* `#12335 <https://github.com/scipy/scipy/pull/12335>`__: MAINT: Work around Sphinx bug
1136
1137