SciPy 1.3.0 發行說明#

SciPy 1.3.0 是 5 個月辛勤工作的成果。它包含許多新功能、大量的錯誤修復、改進的測試覆蓋率和更好的文件。此版本中有一些 API 變更,如下所述。鼓勵所有使用者升級到此版本,因為其中有大量的錯誤修復和最佳化。在升級之前,我們建議使用者檢查他們自己的程式碼是否使用了已棄用的 SciPy 功能(要做到這一點,請使用 python -Wd 執行您的程式碼,並檢查 DeprecationWarning )。我們的開發重心現在將轉移到 1.3.x 分支上的錯誤修復版本,以及在 master 分支上新增新功能。

此版本需要 Python 3.5+ 和 NumPy 1.13.3 或更高版本。

為了在 PyPy 上運行,需要 PyPy3 6.0+ 和 NumPy 1.15.0。

本次發行的重點#

  • 三個新的 stats 函數,pearsonr 的重寫,以及 Kolmogorov-Smirnov 雙樣本檢定的精確計算。

  • scipy.optimize 中有界純量函數尋根器的新 Cython API。

  • CSRCSC 稀疏矩陣索引效能的實質性改進。

  • RotationSpline 中增加了對具有連續角速率和加速度的旋轉插值的支援。

新功能#

scipy.interpolate 改進#

引入了一個新的類別 CubicHermiteSpline。它是一個分段三次插值器,可以匹配觀察值和一階導數。現有的三次插值器 CubicSplinePchipInterpolatorAkima1DInterpolator 被設為 CubicHermiteSpline 的子類別。

scipy.io 改進#

對於屬性關係檔案格式 (ARFF) scipy.io.arff.loadarff 現在支援關係屬性。

scipy.io.mmread 現在可以解析具有空行的 Matrix Market 格式檔案。

scipy.linalg 改進#

?syconv 常式新增了包裝函式,這些常式將三角矩陣分解給定的對稱矩陣轉換為兩個矩陣,反之亦然。

scipy.linalg.clarkson_woodruff_transform 現在使用一種利用稀疏性的演算法。這可能會為密集輸入矩陣提供 60-90% 的加速。真正的稀疏輸入矩陣也應受益於改進的草圖演算法,該演算法現在可以正確地在 O(nnz(A)) 時間內運行。

新增了用於計算對稱 Fiedler 矩陣和 Fiedler 伴生矩陣的新函數,分別命名為 scipy.linalg.fiedlerscipy.linalg.fiedler_companion。這些可用於尋根。

scipy.ndimage 改進#

在某些情況下,由於消除了對 np.polynomial 的依賴性,高斯濾波器的效能可能會提高一個數量級。這可能會影響 scipy.ndimage.gaussian_filter 等函數。

scipy.optimize 改進#

scipy.optimize.brute 最小化器獲得了一個新的關鍵字 workers,可用於並行計算。

scipy.optimize 中有界純量函數尋根器的 Cython API 在新的模組 scipy.optimize.cython_optimize 中透過 cimport 提供。此 API 可以與 nogilprange 一起使用,以迴圈遍歷函數參數陣列,從而比使用純 Python 更快地求解根陣列。

'interior-point' 現在是 linprog 的預設方法,當所需的 scikits (scikit-umfpack 和 scikit-sparse) 可用時,'interior-point' 現在對稀疏問題使用 SuiteSparse。在基準問題 (gh-10026) 上,執行時間縮短了 2-3 倍是典型的。此外,還新增了一個新的 method='revised simplex'。它不如 method='interior-point' 快或穩健,但它是舊版 method='simplex' 的更快、更穩健且同樣準確的替代品。

differential_evolution 現在可以使用 Bounds 類別來指定函數最佳化參數的邊界。

scipy.optimize.dual_annealing 與某些內部程式碼向量化相關的效能改進。

scipy.signal 改進#

scipy.signal.cont2discrete 現在支援兩種額外的離散化方法:impulsefoh

scipy.signal.firls 現在使用更快的求解器。

scipy.signal.detrend 現在在某些情況下具有更低的實體記憶體佔用量,可以使用新的 overwrite_data 關鍵字引數來利用這一點。

scipy.signal.firwin pass_zero 引數現在接受新的字串引數,允許指定所需的濾波器類型:'bandpass''lowpass''highpass''bandstop'

scipy.signal.sosfilt 的效能可能會提高,因為演算法中全域直譯器鎖定 (GIL) 的保留時間更短。

scipy.sparse 改進#

csgraph.dijsktra 新增了一個關鍵字,允許使用者查詢到任何傳入索引的最短路徑,而不是到每個傳入索引的最短路徑。

scipy.sparse.linalg.lsmr 在大型問題上的效能大約提高了 10%。

改進了 scipy.sparse.linalg.lobpcg 使用的演算法的效能並減少了實體記憶體佔用量。

CSRCSC 稀疏矩陣花式索引的效能已大幅改進。

scipy.spatial 改進#

scipy.spatial.ConvexHull 現在有一個 good 屬性,可以與 QGn Qhull 選項一起使用,以確定從外部查詢點可以看到凸包的哪些外部面。

scipy.spatial.cKDTree.query_ball_point 已現代化,以使用一些較新的 Cython 功能,包括 GIL 處理和異常轉換。return_sorted=True 和純量查詢的問題已修復,並新增了一種名為 return_length 的新模式。return_length 僅計算傳回的索引清單的長度,而不是每次都分配陣列。

scipy.spatial.transform.RotationSpline 已新增,以實現具有連續角速率和加速度的旋轉插值。

scipy.stats 改進#

新增了一個新函數來計算 Epps-Singleton 檢定統計量 scipy.stats.epps_singleton_2samp,它可以應用於連續和離散分佈。

新增了新函數 scipy.stats.median_absolute_deviationscipy.stats.gstd (幾何標準差)。scipy.stats.combine_pvalues 方法現在支援 pearsontippettmudholkar_george p 值組合方法。

scipy.stats.ortho_groupscipy.stats.special_ortho_group rvs(dim) 函數的演算法已從 O(dim^4) 實作更新為 O(dim^3),這為 dim>100 帶來了很大的速度提升。

重寫了 scipy.stats.pearsonr 以使用更穩健的演算法,在潛在的病態輸入上提供有意義的異常和警告,並修復了原始實作中至少五個單獨報告的問題。

提高了 hypergeom.logcdfhypergeom.logsf 的精度。

為 Kolmogorov-Smirnov (KS) 雙樣本檢定新增了精確計算,取代了先前對雙尾檢定 stats.ks_2samp 的近似計算。還新增了單尾、雙樣本 KS 檢定,以及 stats.ks_2samp 的關鍵字 alternative

向後不相容的變更#

scipy.interpolate 變更#

已刪除 scipy.interpolate 中的函數 (splevalsplinesplmakespltopp) 以及 scipy.misc 中的函數 (bytescalefromimageimfilterimreadimresizeimrotateimsaveimshowtoimage)。前者自 v0.19.0 起已棄用,後者自 v1.0.0 起已棄用。同樣,自 v1.0.0 起已棄用的 scipy.misc 中的別名 (combfactorialfactorial2factorialklogsumexppadeinfosourcewho) 也被刪除。v1.1.0 的 SciPy 文件可用於追蹤已重新定位函數的新匯入位置。

scipy.linalg 變更#

對於 pinvpinv2pinvh,預設截止值已變更以保持一致性 (請參閱文件以了解實際值)。

scipy.optimize 變更#

linprog 的預設方法現在是 'interior-point'。該方法的穩健性和速度是有代價的:解決方案可能無法精確到機器精度,也可能與約束條件定義的多面體的頂點不對應。要恢復到原始的 simplex 方法,請包含引數 method='simplex'

scipy.stats 變更#

以前,ks_2samp(data1, data2) 將運行雙尾檢定並傳回近似的 p 值。新的簽名 ks_2samp(data1, data2, alternative="two-sided", method="auto") 仍然預設運行雙尾檢定,但對於小樣本傳回精確的 p 值,對於大樣本傳回近似值。method="asymp" 將等同於舊版本,但 auto 是更好的選擇。

其他變更#

我們的教學課程已擴充了一個關於全域最佳化器的新章節。

已經對 stats.distributions 教學課程進行了修改。

scipy.optimize 現在對於有界純量函數尋根器,如果超出最大迭代次數、disp 為 false 且 full_output 為 true,則會正確地將結果的收斂標誌設定為 CONVERR,即收斂錯誤。

scipy.optimize.curve_fit 如果 xdataydata dtypes 不同,則不再失敗;它們現在都會自動轉換為 float64

scipy.ndimage 函數,包括 binary_erosionbinary_closingbinary_dilation,現在需要迭代次數的整數值,這減輕了許多報告的問題。

修復了 scipy.stats.wilcoxonzero_method == "pratt" 情況下的正常近似。

修復了與統計分佈在 _argcheck() 內部設定成員變數相關的錯誤機率、廣播問題和執行緒安全性。

scipy.optimize.newton 現在在以下情況下正確引發 RuntimeError:當使用預設引數並且獲得零值導數時 (這是無法收斂的特殊情況)。

草稿工具鏈路線圖現已發布,其中概述了包括 Python 版本、C 標準和 NumPy 版本在內的相容性計畫。

作者#

  • ananyashreyjain +

  • ApamNapat +

  • Scott Calabrese Barton +

  • Christoph Baumgarten

  • Peter Bell +

  • Jacob Blomgren +

  • Doctor Bob +

  • Mana Borwornpadungkitti +

  • Matthew Brett

  • Evgeni Burovski

  • CJ Carey

  • Vega Theil Carstensen +

  • Robert Cimrman

  • Forrest Collman +

  • Pietro Cottone +

  • David +

  • Idan David +

  • Christoph Deil

  • Dieter Werthmüller

  • Conner DiPaolo +

  • Dowon

  • Michael Dunphy +

  • Peter Andreas Entschev +

  • Gökçen Eraslan +

  • Johann Faouzi +

  • Yu Feng

  • Piotr Figiel +

  • Matthew H Flamm

  • Franz Forstmayr +

  • Christoph Gohlke

  • Richard Janis Goldschmidt +

  • Ralf Gommers

  • Lars Grueter

  • Sylvain Gubian

  • Matt Haberland

  • Yaroslav Halchenko

  • Charles Harris

  • Lindsey Hiltner

  • JakobStruye +

  • He Jia +

  • Jwink3101 +

  • Greg Kiar +

  • Julius Bier Kirkegaard

  • John Kirkham +

  • Thomas Kluyver

  • Vladimir Korolev +

  • Joseph Kuo +

  • Michael Lamparski +

  • Eric Larson

  • Denis Laxalde

  • Katrin Leinweber

  • Jesse Livezey

  • ludcila +

  • Dhruv Madeka +

  • Magnus +

  • Nikolay Mayorov

  • Mark Mikofski

  • Jarrod Millman

  • Markus Mohrhard +

  • Eric Moore

  • Andrew Nelson

  • Aki Nishimura +

  • OGordon100 +

  • Petar Mlinarić +

  • Stefan Peterson

  • Matti Picus +

  • Ilhan Polat

  • Aaron Pries +

  • Matteo Ravasi +

  • Tyler Reddy

  • Ashton Reimer +

  • Joscha Reimer

  • rfezzani +

  • Riadh +

  • Lucas Roberts

  • Heshy Roskes +

  • Mirko Scholz +

  • Taylor D. Scott +

  • Srikrishna Sekhar +

  • Kevin Sheppard +

  • Sourav Singh

  • skjerns +

  • Kai Striega

  • SyedSaifAliAlvi +

  • Gopi Manohar T +

  • Albert Thomas +

  • Timon +

  • Paul van Mulbregt

  • Jacob Vanderplas

  • Daniel Vargas +

  • Pauli Virtanen

  • VNMabus +

  • Stefan van der Walt

  • Warren Weckesser

  • Josh Wilson

  • Nate Yoder +

  • Roman Yurchak

總共有 97 人為此版本做出貢獻。名字旁邊有「+」號的人是第一次貢獻程式碼修補檔。此姓名列表為自動產生,可能未完全列出所有貢獻者。

1.3.0 版本已關閉的議題#

  • #1320: scipy.stats.distribution: problem with self.a, self.b if they…

  • #2002: members set in scipy.stats.distributions.##._argcheck (Trac #1477)

  • #2823: distribution methods add tmp

  • #3220: Scipy.opimize.fmin_powell direc argument syntax unclear

  • #3728: scipy.stats.pearsonr: possible bug with zero variance input

  • #6805: error-in-scipy-wilcoxon-signed-rank-test-for-equal-series

  • #6873: ‘stats.boxcox’ return all same values

  • #7117: Warn users when using float32 input data to curve_fit and friends

  • #7632: it’s not possible to tell the `optimize.least_squares` solver…

  • #7730: stats.pearsonr: Potential division by zero for dataset of length…

  • #7933: stats.truncnorm fails when providing values outside truncation…

  • #8033: Add standard filter types to firwin to set pass_zero intuitively…

  • #8600: lfilter.c.src zfill has erroneous header

  • #8692: Non-negative values of `stats.hypergeom.logcdf`

  • #8734: Enable pip build isolation

  • #8861: scipy.linalg.pinv gives wrong result while scipy.linalg.pinv2…

  • #8915: need to fix macOS build against older numpy versions

  • #8980: scipy.stats.pearsonr overflows with high values of x and y

  • #9226: BUG: signal: SystemError: <built-in function _linear_filter>…

  • #9254: BUG: root finders brentq, etc, flag says “converged” even if…

  • #9308: Test failure - test_initial_constraints_as_canonical

  • #9353: scipy.stats.pearsonr returns r=1 if r_num/r_den = inf

  • #9359: Planck distribution is a geometric distribution

  • #9381: linregress should warn user in 2x2 array case

  • #9406: BUG: stats: In pearsonr, when r is nan, the p-value must also…

  • #9437: Cannot create sparse matrix from size_t indexes

  • #9518: Relational attributes in loadarff

  • #9551: BUG: scipy.optimize.newton says the root of x^2+1 is zero.

  • #9564: rv_sample accepts invalid input in scipy.stats

  • #9565: improper handling of multidimensional input in stats.rv_sample

  • #9581: Least-squares minimization fails silently when x and y data are…

  • #9587: Outdated value for scipy.constants.au

  • #9611: Overflow error with new way of p-value calculation in kendall…

  • #9645: `scipy.stats.mode` crashes with variable length arrays (`dtype=object`)

  • #9734: PendingDeprecationWarning for np.matrix with pytest

  • #9786: stats.ks_2samp() misleading for small data sets.

  • #9790: Excessive memory usage on detrend

  • #9801: dual_annealing does not set the success attribute in OptimizeResult

  • #9833: IntegrationWarning from mielke.stats() during build of html doc.

  • #9835: scipy.signal.firls seems to be inefficient versus MATLAB firls

  • #9864: Curve_fit does not check for empty input data if called with…

  • #9869: scipy.ndimage.label: Minor documentation issue

  • #9882: format at the wrong paranthesis in scipy.spatial.transform

  • #9889: scipy.signal.find_peaks minor documentation issue

  • #9890: Minkowski p-norm Issues in cKDTree For Values Other Than 2 Or…

  • #9896: scipy.stats._argcheck sets (not just checks) values

  • #9905: Memory error in ndimage.binary_erosion

  • #9909: binary_dilation/erosion/closing crashes when iterations is float

  • #9919: BUG: `coo_matrix` does not validate the `shape` argument.

  • #9982: lsq_linear hangs/infinite loop with ‘trf’ method

  • #10003: exponnorm.pdf returns NAN for small K

  • #10011: Incorrect check for invalid rotation plane in scipy.ndimage.rotate

  • #10024: Fails to build from git

  • #10048: DOC: scipy.optimize.root_scalar

  • #10068: DOC: scipy.interpolate.splev

  • #10074: BUG: `expm` calculates the wrong coefficients in the backward…

1.3.0 版本的 Pull Requests#

  • #7827: ENH: sparse: overhaul of sparse matrix indexing

  • #8431: ENH: Cython optimize zeros api

  • #8743: DOC: Updated linalg.pinv, .pinv2, .pinvh docstrings

  • #8744: DOC: added examples to remez docstring

  • #9227: DOC: update description of “direc” parameter of “fmin_powell”

  • #9263: ENH: optimize: added “revised simplex” for scipy.optimize.linprog

  • #9325: DEP: Remove deprecated functions for 1.3.0

  • #9330: Add note on push and pull affine transformations

  • #9423: DOC: Clearly state how 2x2 input arrays are handled in stats.linregress

  • #9428: ENH: parallelised brute

  • #9438: BUG: Initialize coo matrix with size_t indexes

  • #9455: MAINT: Speed up get_(lapack,blas)_func

  • #9465: MAINT: Clean up optimize.zeros C solvers interfaces/code.

  • #9477: DOC: linalg: fix lstsq docstring on residues shape

  • #9478: DOC: Add docstring examples for rosen functions

  • #9479: DOC: Add docstring example for ai_zeros and bi_zeros

  • #9480: MAINT: linalg: lstsq clean up

  • #9489: DOC: roadmap update for changes over the last year.

  • #9492: MAINT: stats: Improve implementation of chi2 ppf method.

  • #9497: DOC: Improve docstrings sparse.linalg.isolve

  • #9499: DOC: Replace “Scipy” with “SciPy” in the .rst doc files for consistency.

  • #9500: DOC: Document the toolchain and its roadmap.

  • #9505: DOC: specify which definition of skewness is used

  • #9511: DEP: interpolate: remove deprecated interpolate_wrapper

  • #9517: BUG: improve error handling in stats.iqr

  • #9522: ENH: Add Fiedler and fiedler companion to special matrices

  • #9526: TST: relax precision requirements in signal.correlate tests

  • #9529: DOC: fix missing random seed in optimize.newton example

  • #9533: MAINT: Use list comprehension when possible

  • #9537: DOC: add a “big picture” roadmap

  • #9538: DOC: Replace “Numpy” with “NumPy” in .py, .rst and .txt doc files…

  • #9539: ENH: add two-sample test (Epps-Singleton) to scipy.stats

  • #9559: DOC: add section on global optimizers to tutorial

  • #9561: ENH: remove noprefix.h, change code appropriately

  • #9562: MAINT: stats: Rewrite pearsonr.

  • #9563: BUG: Minor bug fix Callback in linprog(method=’simplex’)

  • #9568: MAINT: raise runtime error for newton with zeroder if disp true,…

  • #9570: Correct docstring in show_options in optimize. Fixes #9407

  • #9573: BUG fixes range of pk variable pre-check

  • #9577: TST: fix minor issue in a signal.stft test.

  • #9580: Included blank line before list - Fixes #8658

  • #9582: MAINT: drop Python 2.7 and 3.4

  • #9588: MAINT: update `constants.astronomical_unit` to new 2012 value.

  • #9592: TST: Add 32-bit testing to CI

  • #9593: DOC: Replace cumulative density with cumulative distribution

  • #9596: TST: remove VC 9.0 from Azure CI

  • #9599: Hyperlink DOI to preferred resolver

  • #9601: DEV: try to limit GC memory use on PyPy

  • #9603: MAINT: improve logcdf and logsf of hypergeometric distribution

  • #9605: Reference to pylops in LinearOperator notes and ARPACK example

  • #9617: TST: reduce max memory usage for sparse.linalg.lgmres test

  • #9619: FIX: Sparse matrix addition/subtraction eliminates explicit zeros

  • #9621: bugfix in rv_sample in scipy.stats

  • #9622: MAINT: Raise error in directed_hausdorff distance

  • #9623: DOC: Build docs with warnings as errors

  • #9625: Return the number of calls to ‘hessp’ (not just ‘hess’) in trust…

  • #9627: BUG: ignore empty lines in mmio

  • #9637: Function to calculate the MAD of an array

  • #9646: BUG: stats: mode for objects w/ndim > 1

  • #9648: Add `stats.contingency` to refguide-check

  • #9650: ENH: many lobpcg() algorithm improvements

  • #9652: Move misc.doccer to _lib.doccer

  • #9660: ENH: add pearson, tippett, and mudholkar-george to combine_pvalues

  • #9661: BUG: Fix ksone right-hand endpoint, documentation and tests.

  • #9664: ENH: adding multi-target dijsktra performance enhancement

  • #9670: MAINT: link planck and geometric distribution in scipy.stats

  • #9676: ENH: optimize: change default linprog method to interior-point

  • #9685: Added reference to ndimage.filters.median_filter

  • #9705: Fix coefficients in expm helper function

  • #9711: Release the GIL during sosfilt processing for simple types

  • #9721: ENH: Convexhull visiblefacets

  • #9723: BLD: Modify rv_generic._construct_doc to print out failing distribution…

  • #9726: BUG: Fix small issues with `signal.lfilter’

  • #9729: BUG: Typecheck iterations for binary image operations

  • #9730: ENH: reduce sizeof(NI_WatershedElement) by 20%

  • #9731: ENH: remove suspicious sequence of type castings

  • #9739: BUG: qr_updates fails if u is exactly in span Q

  • #9749: BUG: MapWrapper.__exit__ should terminate

  • #9753: ENH: Added exact computation for Kolmogorov-Smirnov two-sample…

  • #9755: DOC: Added example for signal.impulse, copied from impulse2

  • #9756: DOC: Added docstring example for iirdesign

  • #9757: DOC: Added examples for step functions

  • #9759: ENH: Allow pass_zero to act like btype

  • #9760: DOC: Added docstring for lp2bs

  • #9761: DOC: Added docstring and example for lp2bp

  • #9764: BUG: Catch internal warnings for matrix

  • #9766: ENH: Speed up _gaussian_kernel1d by removing dependence on np.polynomial

  • #9769: BUG: Fix Cubic Spline Read Only issues

  • #9773: DOC: Several docstrings

  • #9774: TST: bump Azure CI OpenBLAS version to match wheels

  • #9775: DOC: Improve clarity of cov_x documentation for scipy.optimize.leastsq

  • #9779: ENH: dual_annealing vectorise visit_fn

  • #9788: TST, BUG: f2py-related issues with NumPy < 1.14.0

  • #9791: BUG: fix amax constraint not enforced in scalar_search_wolfe2

  • #9792: ENH: Allow inplace copying in place in “detrend” function

  • #9795: DOC: Fix/update docstring for dstn and dst

  • #9796: MAINT: Allow None tolerances in least_squares

  • #9798: BUG: fixes abort trap 6 error in scipy issue 9785 in unit tests

  • #9807: MAINT: improve doc and add alternative keyword to wilcoxon in…

  • #9808: Fix PPoly integrate and test for CubicSpline

  • #9810: ENH: Add the geometric standard deviation function

  • #9811: MAINT: remove invalid derphi default None value in scalar_search_wolfe2

  • #9813: Adapt hamming distance in C to support weights

  • #9817: DOC: Copy solver description to solver modules

  • #9829: ENH: Add FOH and equivalent impulse response discretizations…

  • #9831: ENH: Implement RotationSpline

  • #9834: DOC: Change mielke distribution default parameters to ensure…

  • #9838: ENH: Use faster solvers for firls

  • #9854: ENH: loadarff now supports relational attributes.

  • #9856: integrate.bvp - improve handling of nonlinear boundary conditions

  • #9862: TST: reduce Appveyor CI load

  • #9874: DOC: Update requirements in release notes

  • #9883: BUG: fixed parenthesis in spatial.rotation

  • #9884: ENH: Use Sparsity in Clarkson-Woodruff Sketch

  • #9888: MAINT: Replace NumPy aliased functions

  • #9892: BUG: Fix 9890 query_ball_point returns wrong result when p is…

  • #9893: BUG: curve_fit doesn’t check for empty input if called with bounds

  • #9894: scipy.signal.find_peaks documentation error

  • #9898: BUG: Set success attribute in OptimizeResult. See #9801

  • #9900: BUG: Restrict rv_generic._argcheck() and its overrides from setting…

  • #9906: fixed a bug in kde logpdf

  • #9911: DOC: replace example for “np.select” with the one from numpy…

  • #9912: BF(DOC): point to numpy.select instead of plain (python) .select

  • #9914: DOC: change ValueError message in _validate_pad of signaltools.

  • #9915: cKDTree query_ball_point improvements

  • #9918: Update ckdtree.pyx with boxsize argument in docstring

  • #9920: BUG: sparse: Validate explicit shape if given with dense argument…

  • #9924: BLD: add back pyproject.toml

  • #9931: Fix empty constraint

  • #9935: DOC: fix references for stats.f_oneway

  • #9936: Revert gh-9619: “FIX: Sparse matrix addition/subtraction eliminates…

  • #9937: MAINT: fix PEP8 issues and update to pycodestyle 2.5.0

  • #9939: DOC: correct `structure` description in `ndimage.label` docstring

  • #9940: MAINT: remove extraneous distutils copies

  • #9945: ENH: differential_evolution can use Bounds object

  • #9949: Added ‘std’ to add doctstrings since it is a `known_stats`…

  • #9953: DOC: Documentation cleanup for stats tutorials.

  • #9962: __repr__ for Bounds

  • #9971: ENH: Improve performance of lsmr

  • #9987: CI: pin Sphinx version to 1.8.5

  • #9990: ENH: constraint violation

  • #9991: BUG: Avoid inplace modification of input array in newton

  • #9995: MAINT: sparse.csgraph: Add cdef to stop build warning.

  • #9996: BUG: Make minimize_quadratic_1d work with infinite bounds correctly

  • #10004: BUG: Fix unbound local error in linprog - simplex.

  • #10007: BLD: fix Python 3.7 build with build isolation

  • #10009: BUG: Make sure that _binary_erosion only accepts an integer number…

  • #10016: Update link to airspeed-velocity

  • #10017: DOC: Update `interpolate.LSQSphereBivariateSpline` to include…

  • #10018: MAINT: special: Fix a few warnings that occur when compiling…

  • #10019: TST: Azure summarizes test failures

  • #10021: ENH: Introduce CubicHermiteSpline

  • #10022: BENCH: Increase cython version in asv to fix benchmark builds

  • #10023: BUG: Avoid exponnorm producing nan for small K values.

  • #10025: BUG: optimize: tweaked linprog status 4 error message

  • #10026: ENH: optimize: use SuiteSparse in linprog interior-point when…

  • #10027: MAINT: cluster: clean up the use of malloc() in the function…

  • #10028: Fix rotate invalid plane check

  • #10040: MAINT: fix pratt method of wilcox test in scipy.stats

  • #10041: MAINT: special: Fix a warning generated when building the AMOS…

  • #10044: DOC: fix up spatial.transform.Rotation docstrings

  • #10047: MAINT: interpolate: Fix a few build warnings.

  • #10051: Add project_urls to setup

  • #10052: don’t set flag to “converged” if max iter exceeded

  • #10054: MAINT: signal: Fix a few build warnings and modernize some C…

  • #10056: BUG: Ensure factorial is not too large in kendaltau

  • #10058: Small speedup in samping from ortho and special_ortho groups

  • #10059: BUG: optimize: fix #10038 by increasing tol

  • #10061: BLD: DOC: make building docs easier by parsing python version.

  • #10064: ENH: Significant speedup for ortho and special ortho group

  • #10065: DOC: Reword parameter descriptions in `optimize.root_scalar`

  • #10066: BUG: signal: Fix error raised by savgol_coeffs when deriv > polyorder.

  • #10067: MAINT: Fix the cutoff value inconsistency for pinv2 and pinvh

  • #10072: BUG: stats: Fix boxcox_llf to avoid loss of precision.

  • #10075: ENH: Add wrappers for ?syconv routines

  • #10076: BUG: optimize: fix curve_fit for mixed float32/float64 input

  • #10077: DOC: Replace undefined `k` in `interpolate.splev` docstring

  • #10079: DOC: Fixed typo, rearranged some doc of stats.morestats.wilcoxon.

  • #10080: TST: install scikit-sparse for full TravisCI tests

  • #10083: Clean ``_clean_inputs`` in optimize.linprog

  • #10088: ENH: optimize: linprog test CHOLMOD/UMFPACK solvers when available

  • #10090: MAINT: Fix CubicSplinerInterpolator for pandas

  • #10091: MAINT: improve logcdf and logsf of hypergeometric distribution

  • #10095: MAINT: Clean ``_clean_inputs`` in linprog

  • #10116: MAINT: update scipy-sphinx-theme

  • #10135: BUG: fix linprog revised simplex docstring problem failure