SciPy 0.19.0 發行說明#

SciPy 0.19.0 是 7 個月辛勤工作的成果。它包含許多新功能、大量的錯誤修正、改進的測試覆蓋率和更好的文件。此版本中存在許多棄用和 API 變更,如下所述。鼓勵所有使用者升級到此版本,因為其中有大量的錯誤修正和最佳化。此外,我們的開發注意力現在將轉移到 0.19.x 分支上的錯誤修正版本,以及在 master 分支上新增新功能。

此版本需要 Python 2.7 或 3.4-3.6 和 NumPy 1.8.2 或更高版本。

此版本的重點包括

  • 統一的外部函式介面層,scipy.LowLevelCallable

  • 來自 scipy.special 模組的通用函式的純量、類型化版本的 Cython API,透過 cimport scipy.special.cython_special

新功能#

外部函式介面改進#

scipy.LowLevelCallable 為在 Python 空間中包裝低階編譯的回呼函式提供新的統一介面。它支援 Cython 匯入的「api」函式、ctypes 函式指標、CFFI 函式指標、PyCapsules、Numba jitted 函式等等。有關詳細資訊,請參閱 gh-6509

scipy.linalg 改進#

函式 scipy.linalg.solve 獲得了另外兩個關鍵字 assume_atransposed。底層 LAPACK 常式已替換為「專家」版本,現在也可以用於求解對稱、埃爾米特和正定係數矩陣。此外,病態矩陣現在會發出警告,並提供估計的條件數資訊。舊的 sym_pos 關鍵字為了向後相容性而保留,但它與使用 assume_a='pos' 相同。此外,debug 關鍵字已棄用,它沒有任何功能,僅列印 overwrite_<a, b> 值。

新增了函式 scipy.linalg.matrix_balance,以使用 LAPACK xGEBAL 常式系列執行所謂的矩陣平衡。這可用於通過對角相似變換來近似地均衡行和列範數。

函式 scipy.linalg.solve_continuous_arescipy.linalg.solve_discrete_are 具有數值上更穩定的演算法。這些函式還可以求解廣義代數矩陣 Riccati 方程式。此外,兩者都獲得了 balanced 關鍵字來開啟和關閉平衡。

scipy.spatial 改進#

scipy.spatial.SphericalVoronoi.sort_vertices_of_regions 已在 Cython 中重新編寫以提高效能。

scipy.spatial.SphericalVoronoi 可以處理 > 200 k 個點(至少 1000 萬個),並且效能有所提高。

新增了函式 scipy.spatial.distance.directed_hausdorff 以計算定向 Hausdorff 距離。

count_neighbors 方法 scipy.spatial.cKDTree 獲得了通過新的關鍵字 weightscumulative 執行加權配對計數的能力。有關詳細資訊,請參閱 gh-5647

scipy.spatial.distance.pdistscipy.spatial.distance.cdist 現在支援非雙精度自訂度量。

scipy.ndimage 改進#

回呼函式 C API 在 Python 2.7 中支援 PyCapsules

多維濾波器現在允許為不同的軸使用不同的外插模式。

scipy.optimize 改進#

scipy.optimize.basinhopping 全域最小化器獲得了一個新的關鍵字 seed,可用於為隨機數字產生器播種並獲得可重複的最小化。

scipy.optimize.curve_fit 中的關鍵字 sigma 已超載,也接受資料中誤差的共變異數矩陣。

scipy.signal 改進#

函式 scipy.signal.correlatescipy.signal.convolve 有一個新的可選參數 methodauto 的預設值估計兩種計算方法中最快的方法,即直接方法和傅立葉轉換方法。

新增了一個新函式來選擇卷積/相關方法 scipy.signal.choose_conv_method,如果對許多相同大小的陣列執行卷積或相關,則此函式可能適用。

新增了新函式來計算輸入訊號的複數短時傅立葉轉換,並反轉轉換以恢復原始訊號:scipy.signal.stftscipy.signal.istft。此實作也修正了先前在請求複雜輸出資料時 scipy.signal.spectrogram 的不正確輸出。

新增了函式 scipy.signal.sosfreqz,以從二階區段計算頻率響應。

新增了函式 scipy.signal.unit_impulse,以方便地產生脈衝函數。

新增了函式 scipy.signal.iirnotch,以設計二階 IIR 陷波濾波器,可用於從訊號中移除頻率分量。新增了雙重函式 scipy.signal.iirpeak,以計算二階 IIR 峰值(共振)濾波器的係數。

新增了函式 scipy.signal.minimum_phase,以將線性相位 FIR 濾波器轉換為最小相位。

當在某些 n 維陣列上運作且 n > 1 時,函式 scipy.signal.upfirdnscipy.signal.resample_poly 現在速度明顯更快。在陣列沿著要篩選的軸尺寸較小(約 <1k 個樣本)的情況下,運算時間的縮短幅度最大。

scipy.fftpack 改進#

快速傅立葉轉換常式現在接受 np.float16 輸入,並將其向上轉換為 np.float32。先前,它們會引發錯誤。

scipy.cluster 改進#

scipy.cluster.hierarchy.linkage 的方法 "centroid""median" 已顯著加速。使用 linkage 處理大型輸入資料(超過 16 GB)的長期存在的問題已解決。

scipy.sparse 改進#

新增了函式 scipy.sparse.save_npzscipy.sparse.load_npz,為某些稀疏格式提供簡單的序列化。

更新了類別 bsr_matrixcsc_matrixcsr_matrixprune 方法,以便在特定條件下重新分配後備陣列,從而減少記憶體使用量。

將方法 argminargmax 新增至類別 coo_matrixcsc_matrixcsr_matrixbsr_matrix

新函式 scipy.sparse.csgraph.structural_rank 計算具有給定稀疏模式的圖形的結構秩。

新函式 scipy.sparse.linalg.spsolve_triangular 求解具有三角形左側矩陣的稀疏線性系統。

scipy.special 改進#

透過從新模組 scipy.special.cython_special 進行 cimport,可以在 Cython 空間中使用來自 scipy.special 的通用函式的純量、類型化版本。對於純量引數,這些純量函式預計會比通用函式快得多。有關詳細資訊,請參閱 scipy.special 教學課程。

函式 scipy.special.geterrscipy.special.seterr 和上下文管理器 scipy.special.errstate 提供了對特殊函式錯誤的更好控制。

正交多項式根函式的名稱已更改,以與與正交多項式相關的其他函式保持一致。例如,scipy.special.j_roots 已重新命名為 scipy.special.roots_jacobi,以與相關函式 scipy.special.jacobiscipy.special.eval_jacobi 保持一致。為了保持向後相容性,舊名稱已保留為別名。

Wright Omega 函式實作為 scipy.special.wrightomega

scipy.stats 改進#

新增了函式 scipy.stats.weightedtau。它提供了 Kendall's tau 的加權版本。

新類別 scipy.stats.multinomial 實作了多項式分布。

新類別 scipy.stats.rv_histogram 從分箱資料樣本建構具有分段線性 CDF 的連續單變數分布。

新類別 scipy.stats.argus 實作了 Argus 分布。

scipy.interpolate 改進#

新類別 scipy.interpolate.BSpline 代表樣條。BSpline 物件包含節點和係數,並且可以評估樣條。格式與 FITPACK 一致,因此可以執行以下操作,例如

>>> t, c, k = splrep(x, y, s=0)
>>> spl = BSpline(t, c, k)
>>> np.allclose(spl(x), y)

spl* 函式、scipy.interpolate.splevscipy.interpolate.splintscipy.interpolate.splderscipy.interpolate.splantider,接受 BSpline 物件和 (t, c, k) 元組以實現向後相容性。

對於多維樣條,c.ndim > 1BSpline 物件與分段多項式 scipy.interpolate.PPoly 一致。這表示 BSpline 物件與 scipy.interpolate.splprep 不立即一致,並且無法執行 >>> BSpline(*splprep([x, y])[0])。有關精確等效性的範例,請參閱 scipy.interpolate 測試套件。

在新程式碼中,請優先使用 scipy.interpolate.BSpline 物件,而不是直接操作 (t, c, k) 元組。

新函式 scipy.interpolate.make_interp_spline 建構給定資料點和邊界條件的內插樣條。

新函式 scipy.interpolate.make_lsq_spline 建構給定資料點的最小平方樣條逼近。

scipy.integrate 改進#

現在 scipy.integrate.fixed_quad 支援向量值函數。

已棄用的功能#

scipy.interpolate.splmakescipy.interpolate.splevalscipy.interpolate.spline 已棄用。splmake/spleval 使用的格式與 splrep/splev 不一致,這會讓使用者感到困惑。

scipy.special.errprint 已棄用。改進的功能可在 scipy.special.seterr 中找到。

呼叫 scipy.spatial.distance.pdistscipy.spatial.distance.cdist 時,使用所選度量不需要的引數已棄用。此外,度量 “old_cosine”“old_cos” 已棄用。

向後不相容的變更#

已移除已棄用的 scipy.weave 子模組。

scipy.spatial.distance.squareform 現在傳回與輸入 dtype 相同的陣列,而不是始終傳回 float64。

scipy.special.errprint 現在傳回布林值。

函數 scipy.signal.find_peaks_cwt 現在返回的是陣列而不是列表。

scipy.stats.kendalltau 現在計算在輸入包含平局的情況下正確的 p 值 (p-value)。這個 p 值也與 scipy.stats.mstats.kendalltau 和 R 計算出的 p 值相同。如果輸入不包含平局,則相對於之前的實作沒有任何變化。

函數 scipy.linalg.block_diag 將不再忽略零尺寸的矩陣。而是會插入適當大小的零行或零列。詳情請參閱 gh-4908。

其他變更#

SciPy wheels 現在將在所有平台上報告它們對 numpy 的依賴性。做出此變更是因為 Numpy wheels 現在可用,而且 pip 升級行為最終變得更好(對於 pip >= 8.2 使用 --upgrade-strategy=only-if-needed;該行為將在下一個主要版本的 pip 中成為預設值)。

scipy.interpolate.interp1dkind="cubic""quadratic" 返回的數值可能相對於之前的 scipy 版本發生變化。如果您的程式碼依賴於特定的數值(即,插值器的實作細節),您可能需要仔細檢查您的結果。

作者#

  • @endolith

  • Max Argus +

  • Hervé Audren

  • Alessandro Pietro Bardelli +

  • Michael Benfield +

  • Felix Berkenkamp

  • Matthew Brett

  • Per Brodtkorb

  • Evgeni Burovski

  • Pierre de Buyl

  • CJ Carey

  • Brandon Carter +

  • Tim Cera

  • Klesk Chonkin

  • Christian Häggström +

  • Luca Citi

  • Peadar Coyle +

  • Daniel da Silva +

  • Greg Dooper +

  • John Draper +

  • drlvk +

  • David Ellis +

  • Yu Feng

  • Baptiste Fontaine +

  • Jed Frey +

  • Siddhartha Gandhi +

  • Wim Glenn +

  • Akash Goel +

  • Christoph Gohlke

  • Ralf Gommers

  • Alexander Goncearenco +

  • Richard Gowers +

  • Alex Griffing

  • Radoslaw Guzinski +

  • Charles Harris

  • Callum Jacob Hays +

  • Ian Henriksen

  • Randy Heydon +

  • Lindsey Hiltner +

  • Gerrit Holl +

  • Hiroki IKEDA +

  • jfinkels +

  • Mher Kazandjian +

  • Thomas Keck +

  • keuj6 +

  • Kornel Kielczewski +

  • Sergey B Kirpichev +

  • Vasily Kokorev +

  • Eric Larson

  • Denis Laxalde

  • Gregory R. Lee

  • Josh Lefler +

  • Julien Lhermitte +

  • Evan Limanto +

  • Jin-Guo Liu +

  • Nikolay Mayorov

  • Geordie McBain +

  • Josue Melka +

  • Matthieu Melot

  • michaelvmartin15 +

  • Surhud More +

  • Brett M. Morris +

  • Chris Mutel +

  • Paul Nation

  • Andrew Nelson

  • David Nicholson +

  • Aaron Nielsen +

  • Joel Nothman

  • nrnrk +

  • Juan Nunez-Iglesias

  • Mikhail Pak +

  • Gavin Parnaby +

  • Thomas Pingel +

  • Ilhan Polat +

  • Aman Pratik +

  • Sebastian Pucilowski

  • Ted Pudlik

  • puenka +

  • Eric Quintero

  • Tyler Reddy

  • Joscha Reimer

  • Antonio Horta Ribeiro +

  • Edward Richards +

  • Roman Ring +

  • Rafael Rossi +

  • Colm Ryan +

  • Sami Salonen +

  • Alvaro Sanchez-Gonzalez +

  • Johannes Schmitz

  • Kari Schoonbee

  • Yurii Shevchuk +

  • Jonathan Siebert +

  • Jonathan Tammo Siebert +

  • Scott Sievert +

  • Sourav Singh

  • Byron Smith +

  • Srikiran +

  • Samuel St-Jean +

  • Yoni Teitelbaum +

  • Bhavika Tekwani

  • Martin Thoma

  • timbalam +

  • Svend Vanderveken +

  • Sebastiano Vigna +

  • Aditya Vijaykumar +

  • Santi Villalba +

  • Ze Vinicius

  • Pauli Virtanen

  • Matteo Visconti

  • Yusuke Watanabe +

  • Warren Weckesser

  • Phillip Weinberg +

  • Nils Werner

  • Jakub Wilk

  • Josh Wilson

  • wirew0rm +

  • David Wolever +

  • Nathan Woods

  • ybeltukov +

  • G Young

  • Evgeny Zhurko +

總共有 121 人為此版本做出了貢獻。名字旁邊帶有「+」號的人是首次貢獻 patch。這個名字列表是自動生成的,可能不完全完整。

為 0.19.0 關閉的 Issue#

  • #1767: Function definitions in __fitpack.h should be moved. (Trac #1240)

  • #1774: _kmeans chokes on large thresholds (Trac #1247)

  • #2089: Integer overflows cause segfault in linkage function with large…

  • #2190: Are odd-length window functions supposed to be always symmetrical?…

  • #2251: solve_discrete_are in scipy.linalg does (sometimes) not solve…

  • #2580: scipy.interpolate.UnivariateSpline (or a new superclass of it)…

  • #2592: scipy.stats.anderson assumes gumbel_l

  • #3054: scipy.linalg.eig does not handle infinite eigenvalues

  • #3160: multinomial pmf / logpmf

  • #3904: scipy.special.ellipj dn wrong values at quarter period

  • #4044: Inconsistent code book initialization in kmeans

  • #4234: scipy.signal.flattop documentation doesn’t list a source for…

  • #4831: Bugs in C code in __quadpack.h

  • #4908: bug: unnessesary validity check for block dimension in scipy.sparse.block_diag

  • #4917: BUG: indexing error for sparse matrix with ix_

  • #4938: Docs on extending ndimage need to be updated.

  • #5056: sparse matrix element-wise multiplying dense matrix returns dense…

  • #5337: Formula in documentation for correlate is wrong

  • #5537: use OrderedDict in io.netcdf

  • #5750: [doc] missing data index value in KDTree, cKDTree

  • #5755: p-value computation in scipy.stats.kendalltau() in broken in…

  • #5757: BUG: Incorrect complex output of signal.spectrogram

  • #5964: ENH: expose scalar versions of scipy.special functions to cython

  • #6107: scipy.cluster.hierarchy.single segmentation fault with 2**16…

  • #6278: optimize.basinhopping should take a RandomState object

  • #6296: InterpolatedUnivariateSpline: check_finite fails when w is unspecified

  • #6306: Anderson-Darling bad results

  • #6314: scipy.stats.kendaltau() p value not in agreement with R, SPSS…

  • #6340: Curve_fit bounds and maxfev

  • #6377: expm_multiply, complex matrices not working using start,stop,etc…

  • #6382: optimize.differential_evolution stopping criterion has unintuitive…

  • #6391: Global Benchmarking times out at 600s.

  • #6397: mmwrite errors with large (but still 64-bit) integers

  • #6413: scipy.stats.dirichlet computes multivariate gaussian differential…

  • #6428: scipy.stats.mstats.mode modifies input

  • #6440: Figure out ABI break policy for scipy.special Cython API

  • #6441: Using Qhull for halfspace intersection : segfault

  • #6442: scipy.spatial : In incremental mode volume is not recomputed

  • #6451: Documentation for scipy.cluster.hierarchy.to_tree is confusing…

  • #6490: interp1d (kind=zero) returns wrong value for rightmost interpolation…

  • #6521: scipy.stats.entropy does not calculate the KL divergence

  • #6530: scipy.stats.spearmanr unexpected NaN handling

  • #6541: Test runner does not run scipy._lib/tests?

  • #6552: BUG: misc.bytescale returns unexpected results when using cmin/cmax…

  • #6556: RectSphereBivariateSpline(u, v, r) fails if min(v) >= pi

  • #6559: Differential_evolution maxiter causing memory overflow

  • #6565: Coverage of spectral functions could be improved

  • #6628: Incorrect parameter name in binomial documentation

  • #6634: Expose LAPACK’s xGESVX family for linalg.solve ill-conditioned…

  • #6657: Confusing documentation for scipy.special.sph_harm

  • #6676: optimize: Incorrect size of Jacobian returned by `minimize(…,…

  • #6681: add a new context manager to wrap scipy.special.seterr

  • #6700: BUG: scipy.io.wavfile.read stays in infinite loop, warns on wav…

  • #6721: scipy.special.chebyt(N) throw a ‘TypeError’ when N > 64

  • #6727: Documentation for scipy.stats.norm.fit is incorrect

  • #6764: Documentation for scipy.spatial.Delaunay is partially incorrect

  • #6811: scipy.spatial.SphericalVoronoi fails for large number of points

  • #6841: spearmanr fails when nan_policy=’omit’ is set

  • #6869: Currently in gaussian_kde, the logpdf function is calculated…

  • #6875: SLSQP inconsistent handling of invalid bounds

  • #6876: Python stopped working (Segfault?) with minimum/maximum filter…

  • #6889: dblquad gives different results under scipy 0.17.1 and 0.18.1

  • #6898: BUG: dblquad ignores error tolerances

  • #6901: Solving sparse linear systems in CSR format with complex values

  • #6903: issue in spatial.distance.pdist docstring

  • #6917: Problem in passing drop_rule to scipy.sparse.linalg.spilu

  • #6926: signature mismatches for LowLevelCallable

  • #6961: Scipy contains shebang pointing to /usr/bin/python and /bin/bash…

  • #6972: BUG: special: generate_ufuncs.py is broken

  • #6984: Assert raises test failure for test_ill_condition_warning

  • #6990: BUG: sparse: Bad documentation of the k argument in sparse.linalg.eigs

  • #6991: Division by zero in linregress()

  • #7011: possible speed improvment in rv_continuous.fit()

  • #7015: Test failure with Python 3.5 and numpy master

  • #7055: SciPy 0.19.0rc1 test errors and failures on Windows

  • #7096: macOS test failues for test_solve_continuous_are

  • #7100: test_distance.test_Xdist_deprecated_args test error in 0.19.0rc2

為 0.19.0 的 Pull Request#

  • #2908: Scipy 1.0 Roadmap

  • #3174: add b-splines

  • #4606: ENH: Add a unit impulse waveform function

  • #5608: Adds keyword argument to choose faster convolution method

  • #5647: ENH: Faster count_neighour in cKDTree / + weighted input data

  • #6021: Netcdf append

  • #6058: ENH: scipy.signal - Add stft and istft

  • #6059: ENH: More accurate signal.freqresp for zpk systems

  • #6195: ENH: Cython interface for special

  • #6234: DOC: Fixed a typo in ward() help

  • #6261: ENH: add docstring and clean up code for signal.normalize

  • #6270: MAINT: special: add tests for cdflib

  • #6271: Fix for scipy.cluster.hierarchy.is_isomorphic

  • #6273: optimize: rewrite while loops as for loops

  • #6279: MAINT: Bessel tweaks

  • #6291: Fixes gh-6219: remove runtime warning from genextreme distribution

  • #6294: STY: Some PEP8 and cleaning up imports in stats/_continuous_distns.py

  • #6297: Clarify docs in misc/__init__.py

  • #6300: ENH: sparse: Loosen input validation for diags with empty inputs

  • #6301: BUG: standardizes check_finite behavior re optional weights,…

  • #6303: Fixing example in _lazyselect docstring.

  • #6307: MAINT: more improvements to gammainc/gammaincc

  • #6308: Clarified documentation of hypergeometric distribution.

  • #6309: BUG: stats: Improve calculation of the Anderson-Darling statistic.

  • #6315: ENH: Descending order of x in PPoly

  • #6317: ENH: stats: Add support for nan_policy to stats.median_test

  • #6321: TST: fix a typo in test name

  • #6328: ENH: sosfreqz

  • #6335: Define LinregressResult outside of linregress

  • #6337: In anderson test, added support for right skewed gumbel distribution.

  • #6341: Accept several spellings for the curve_fit max number of function…

  • #6342: DOC: cluster: clarify hierarchy.linkage usage

  • #6352: DOC: removed brentq from its own ‘see also’

  • #6362: ENH: stats: Use explicit formulas for sf, logsf, etc in weibull…

  • #6369: MAINT: special: add a comment to hyp0f1_complex

  • #6375: Added the multinomial distribution.

  • #6387: MAINT: special: improve accuracy of ellipj’s dn at quarter…

  • #6388: BenchmarkGlobal - getting it to work in Python3

  • #6394: ENH: scipy.sparse: add save and load functions for sparse matrices

  • #6400: MAINT: moves global benchmark run from setup_cache to track_all

  • #6403: ENH: seed kwd for basinhopping. Closes #6278

  • #6404: ENH: signal: added irrnotch and iirpeak functions.

  • #6406: ENH: special: extend sici/shichi to complex arguments

  • #6407: ENH: Window functions should not accept non-integer or negative…

  • #6408: MAINT: _differentialevolution now uses _lib._util.check_random_state

  • #6427: MAINT: Fix gmpy build & test that mpmath uses gmpy

  • #6439: MAINT: ndimage: update callback function c api

  • #6443: BUG: Fix volume computation in incremental mode

  • #6447: Fixes issue #6413 - Minor documentation fix in the entropy function…

  • #6448: ENH: Add halfspace mode to Qhull

  • #6449: ENH: rtol and atol for differential_evolution termination fixes…

  • #6453: DOC: Add some See Also links between similar functions

  • #6454: DOC: linalg: clarify callable signature in ordqz

  • #6457: ENH: spatial: enable non-double dtypes in squareform

  • #6459: BUG: Complex matrices not handled correctly by expm_multiply…

  • #6465: TST DOC Window docs, tests, etc.

  • #6469: ENH: linalg: better handling of infinite eigenvalues in eig/eigvals

  • #6475: DOC: calling interp1d/interp2d with NaNs is undefined

  • #6477: Document magic numbers in optimize.py

  • #6481: TST: Supress some warnings from test_windows

  • #6485: DOC: spatial: correct typo in procrustes

  • #6487: Fix Bray-Curtis formula in pdist docstring

  • #6493: ENH: Add covariance functionality to scipy.optimize.curve_fit

  • #6494: ENH: stats: Use log1p() to improve some calculations.

  • #6495: BUG: Use MST algorithm instead of SLINK for single linkage clustering

  • #6497: MRG: Add minimum_phase filter function

  • #6505: reset scipy.signal.resample window shape to 1-D

  • #6507: BUG: linkage: Raise exception if y contains non-finite elements

  • #6509: ENH: _lib: add common machinery for low-level callback functions

  • #6520: scipy.sparse.base.__mul__ non-numpy/scipy objects with ‘shape’…

  • #6522: Replace kl_div by rel_entr in entropy

  • #6524: DOC: add next_fast_len to list of functions

  • #6527: DOC: Release notes to reflect the new covariance feature in optimize.curve_fit

  • #6532: ENH: Simplify _cos_win, document it, add symmetric/periodic arg

  • #6535: MAINT: sparse.csgraph: updating old cython loops

  • #6540: DOC: add to documentation of orthogonal polynomials

  • #6544: TST: Ensure tests for scipy._lib are run by scipy.test()

  • #6546: updated docstring of stats.linregress

  • #6553: commited changes that I originally submitted for scipy.signal.cspline…

  • #6561: BUG: modify signal.find_peaks_cwt() to return array and accept…

  • #6562: DOC: Negative binomial distribution clarification

  • #6563: MAINT: be more liberal in requiring numpy

  • #6567: MAINT: use xrange for iteration in differential_evolution fixes…

  • #6572: BUG: “sp.linalg.solve_discrete_are” fails for random data

  • #6578: BUG: misc: allow both cmin/cmax and low/high params in bytescale

  • #6581: Fix some unfortunate typos

  • #6582: MAINT: linalg: make handling of infinite eigenvalues in ordqz

  • #6585: DOC: interpolate: correct seealso links to ndimage

  • #6588: Update docstring of scipy.spatial.distance_matrix

  • #6592: DOC: Replace ‘first’ by ‘smallest’ in mode

  • #6593: MAINT: remove scipy.weave submodule

  • #6594: DOC: distance.squareform: fix html docs, add note about dtype…

  • #6598: [DOC] Fix incorrect error message in medfilt2d

  • #6599: MAINT: linalg: turn a solve_discrete_are test back on

  • #6600: DOC: Add SOS goals to roadmap

  • #6601: DEP: Raise minimum numpy version to 1.8.2

  • #6605: MAINT: ‘new’ module is deprecated, don’t use it

  • #6607: DOC: add note on change in wheel dependency on numpy and pip…

  • #6609: Fixes #6602 - Typo in docs

  • #6616: ENH: generalization of continuous and discrete Riccati solvers…

  • #6621: DOC: improve cluster.hierarchy docstrings.

  • #6623: CS matrix prune method should copy data from large unpruned arrays

  • #6625: DOC: special: complete documentation of eval_* functions

  • #6626: TST: special: silence some deprecation warnings

  • #6631: fix parameter name doc for discrete distributions

  • #6632: MAINT: stats: change some instances of special to sc

  • #6633: MAINT: refguide: py2k 長整數等同於 py3k 整數

  • #6638: MAINT: 變更 cluster.linkage 中的類型宣告,防止溢位

  • #6640: BUG: 修正 cluster.vq.kmeans 中使用重複數值的問題

  • #6641: BUG: 修正 cluster.vq.kmeans 中大型閾值的邊角案例

  • #6643: MAINT: 清理樹狀圖的截斷模式

  • #6645: MAINT: special: 重新命名 *_roots 函數

  • #6646: MAINT: 清理 mpmath 導入

  • #6647: DOC: 為 pdist 的 Mahalanobis 描述新增 sqrt

  • #6648: DOC: special: 在教學中新增關於 cython_special 的章節

  • #6649: ENH: 新增 scipy.spatial.distance.directed_hausdorff

  • #6650: DOC: 為 DOI 和 arXiv 連結新增 Sphinx 角色

  • #6651: BUG: mstats: 確保 mode(…, None) 不會修改其輸入

  • #6652: DOC: special: 在教學中新增關於不在 special 中的函數的章節

  • #6653: ENH: special: 新增 Wright Omega 函數

  • #6656: ENH: 在 cdist 中使用自訂度量時,不要強制輸入為 double

  • #6658: 更快/更短的程式碼來計算不一致性

  • #6659: DOC: special: 使 __init__ 摘要和 html 摘要匹配

  • #6661: general.rst: 修正錯字

  • #6664: TST: 頻譜函數的視窗校正因子

  • #6665: [DOC] RectSphereBivariateSpline 中 v 的條件

  • #6668: DOC: 提及質心可以為負質量

  • #6675: MAINT: special: 移除過時的 README

  • #6677: BUG: 錯誤修正: 修正 p 值的計算。

  • #6679: BUG: optimize: 為方法 ‘SLSQP’ 返回正確的 Jacobian 在…

  • #6680: ENH: 為 sparse.csgraph 新增結構秩

  • #6686: TST: 為 SphericalVoronoi 新增 Airspeed Velocity 效能基準

  • #6687: DOC: 在開發者指南中新增 “決定新功能” 的章節。

  • #6691: ENH: 當 fmin_slsqp obj 沒有返回純量時,提供更清晰的錯誤訊息

  • #6702: TST: 為 scipy.spatial.distance.cdist 新增 airspeed velocity 效能基準

  • #6707: TST: interpolate: 測試 fitpack 包裝器,而不是 _impl

  • #6709: TST: 修正 32 位元系統上的一些測試失敗

  • #6711: MAINT: 將函數定義從 __fitpack.h 移動到 _fitpackmodule.c

  • #6712: MAINT: 清理 stats.morestats 中的願望清單和版權聲明。

  • #6715: DOC: 使用 BSpline 等更新發行版本說明

  • #6716: MAINT: scipy.io.wavfile: 嘗試讀取時不會無限迴圈…

  • #6717: 一些樣式清理

  • #6723: BUG: special: 在 in-place 乘法中先轉換為 float 在…

  • #6726: 解決 interp1d 中的效能回歸問題

  • #6728: DOC: 使 integrate 教學中的程式碼範例變得可複製貼上

  • #6731: DOC: scipy.optimize: 為封裝複數值新增範例…

  • #6732: MAINT: cython_special: 移除 errprint

  • #6733: MAINT: special: 修正一些 pyflakes 警告

  • #6734: DOC: sparse.linalg: 修正 bicgstab 文件中的矩陣描述

  • #6737: BLD: 更新 cythonize.py 以偵測 pxi 檔案中的變更

  • #6740: DOC: special: 對於文件字串的一些小修正

  • #6741: MAINT: 移除 interpolate.py 中的無效程式碼

  • #6742: BUG: 修正 linalg.block_diag 以支援零尺寸矩陣。

  • #6744: ENH: interpolate: 使 PPoly.from_spline 接受 BSpline 物件

  • #6746: DOC: special: 釐清 sph_harm/lpmv 中 Condon-Shortley 相位的用法

  • #6750: ENH: sparse: 避免在廣播元素級乘法時進行密集化

  • #6751: sinm 文件解釋了 cosm

  • #6753: ENH: special: 允許更精細的錯誤處理

  • #6759: 將 logsumexp 和 pade 從 scipy.misc 移動到 scipy.special 和…

  • #6761: ENH: sparse 矩陣的 argmax 和 argmin 方法

  • #6762: DOC: 改進 sparse 矩陣的文件字串

  • #6763: ENH: 加權 tau

  • #6768: ENH: cythonized 球形 Voronoi 區域多邊形頂點排序

  • #6770: Delaunay 類別文件修正

  • #6775: ENH: 整合 LAPACK “專家” 常式與條件警告…

  • #6776: MAINT: 移除不重要的 f2py 警告

  • #6777: DOC: 更新 rv_continuous.fit 文件。

  • #6778: MAINT: cluster.hierarchy: 改進錯誤訊息的措辭

  • #6786: BLD: 將最低 Cython 版本提高到 0.23.4

  • #6787: DOC: 擴展 0.19.0 版本中 linalg.block_diag 的變更…

  • #6789: ENH: 為 norm.fit 新增更多文件

  • #6790: MAINT: 修正 nn_chain linkage 演算法中的潛在問題

  • #6791: DOC: 為 scipy.ndimage.fourier 新增範例

  • #6792: DOC: 修正一些 numpydoc / Sphinx 問題。

  • #6793: MAINT: 修正將函數移出 misc 後的循環導入問題

  • #6796: TST: 測試導入每個子模組。gh-6793 的迴歸測試。

  • #6799: ENH: stats: Argus 分佈

  • #6801: ENH: stats: 直方圖分佈

  • #6803: TST: 確保 _build_utils 的測試有被執行。

  • #6804: MAINT: loggamma 中的更多修正

  • #6806: ENH: 更快的 ‘centroid’ 和 ‘median’ 方法的 linkage

  • #6810: ENH: 加速 n 維陣列的 upfirdn 和 resample_poly

  • #6812: TST: 新增 ConvexHull asv 效能基準程式碼

  • #6814: ENH: 在…中針對不同維度使用不同的外插模式

  • #6826: Signal spectral window 預設修正

  • #6828: BUG: SphericalVoronoi 空間複雜度 (修正 #6811)

  • #6830: RealData 文件字串修正

  • #6834: DOC: 為 skewtest 函數新增參考文獻。參見 #6829

  • #6836: DOC: 在接受…的函數的文件字串中新增 mode=’mirror’

  • #6838: MAINT: sparse: 開始移除舊的 BSR 方法

  • #6844: 當輸入不是 ndarray 時,處理不相容的維度在…

  • #6847: 為黃金搜尋法新增 maxiter。

  • #6850: BUG: 為可選參數 scipy.stats.spearmanr 新增檢查

  • #6858: MAINT: 移除多餘的測試

  • #6861: DEP: 修正 Python 3.6 中已棄用的跳脫序列。

  • #6862: DOC: dx 應該是 float,而不是 int

  • #6863: 更新 curve_fit 文件

  • #6866: DOC : 為 j1 新增一些參考 spherical_jn 的文件

  • #6867: DOC: cdist 將長範例列表移動到 Notes 章節

  • #6868: BUG: 使 stats.mode 在空值時返回 ModeResult 命名元組…

  • #6871: 已修正文件。

  • #6874: ENH: gaussian_kde.logpdf 基於 logsumexp

  • #6877: BUG: ndimage: 防止全零的 footprint

  • #6881: python 3.6

  • #6885: Vectorized integrate.fixed_quad

  • #6886: 修正錯字

  • #6891: TST: 修正 linalg.dare/care 因收緊測試而失敗的問題…

  • #6892: DOC: 修正一堆 Sphinx 錯誤。

  • #6894: TST: 為 scipy.spatial.Voronoi 新增 asv 效能基準

  • #6908: BUG: 修正 spsolve 中複數輸入的返回 dtype

  • #6909: ENH: fftpack: 為 float16 輸入使用 float32 常式。

  • #6911: 為 binned_statistic 新增 min/max 支援

  • #6913: 修正 6875: SLSQP 為所有無效邊界引發 ValueError。

  • #6914: DOCS: GH6903 更新 Spatial.distance.pdist 的文件

  • #6916: MAINT: 修正 32 位元 Python 的一些問題

  • #6924: BLD: 更新 scipy.LowLevelCallable 的 Bento 建置

  • #6932: ENH: 在 io.netcdf 中使用 OrderedDict。關閉 gh-5537

  • #6933: BUG: 修正 32 位元 Python 上的 LowLevelCallable 問題。

  • #6936: BUG: sparse: 正確處理大小為 1 的 2D 索引

  • #6938: TST: 修正 32 位元 Python 上 special 中的測試失敗。

  • #6939: 為 cKDTree 文件字串新增屬性列表

  • #6940: 提高 dok_matrix.tocoo 的效率

  • #6942: DOC: 在 io.arff 文件字串中新增 liac-arff 套件的連結。

  • #6943: MAINT: 文件字串修正和 linalg.solve 的額外測試

  • #6944: DOC: 為 integrate 新增帶狀 Jacobian 的 odeint 範例…

  • #6946: ENH: 以 betaln 表示的 hypergeom.logpmf

  • #6947: TST: 加速距離測試

  • #6948: DEP: 棄用 linalg.solve 中的關鍵字 “debug”

  • #6950: BUG: 正確處理 MMIO 中的大型整數 (修正 #6397)

  • #6952: ENH: LowLevelCallable 中微小的使用者友善性清理

  • #6956: DOC: 改進 convolve 的 ‘output’ 關鍵字的描述

  • #6957: ENH sparse.bmat 中更豐富的錯誤訊息

  • #6962: Shebang 修正

  • #6964: DOC: 註記 argmin/argmax 的新增

  • #6965: BUG: 修正 dblquad 和 tplquad 中傳遞錯誤容忍度的問題。

  • #6971: 修正 signaltools.correlate 的文件字串

  • #6973: 消除 scipy.ndimage.interpolation.zoom() 中預期的 numpy 警告

  • #6975: BUG: special: 修正 generate_ufuncs.py 中的正則表達式

  • #6976: 更新 griddata 的文件字串

  • #6978: 避免在縮放因子計算中除以零

  • #6979: BUG: ARE 求解器沒有仔細檢查廣義情況

  • #6985: ENH: sparse: 新增 scipy.sparse.linalg.spsolve_triangular

  • #6994: MAINT: spatial: 更新繪圖工具

  • #6995: DOC: sparse.linalg.eigs 中 k 的文件不良,參見 #6990

  • #6997: TST: 將測試變更為較不奇異的範例

  • #7000: DOC: 釐清 interp1d ‘zero’ 參數

  • #7007: BUG: 修正 linregress() 在 2 個資料點時除以零的問題

  • #7009: BUG: 修正將 drop_rule 傳遞給 scipy.sparse.linalg.spilu 的問題

  • #7012: 改善 _distn_infrastructure.py 中的速度

  • #7014: 修正錯字:新增單引號以修正輕微錯字

  • #7021: MAINT: stats: 使用來自 np.finfo 的機器常數,而不是 machar

  • #7026: MAINT: 更新 .mailmap

  • #7032: 修正 rv_histogram 文件的版面配置

  • #7035: DOC: 更新 0.19.0 發行版本說明

  • #7036: ENH: 為 signal.stft 新增更多邊界選項

  • #7040: TST: stats: 跳過太慢的測試

  • #7042: MAINT: sparse: 加速 setdiag 測試

  • #7043: MAINT: 重構和程式碼清理 Xdist

  • #7053: 修正 msvc 9 和 10 編譯錯誤

  • #7060: DOC: 使用 #7043 和 #6656 更新發行版本說明

  • #7062: MAINT: 將預設 STFT 邊界 kwarg 變更為 “zeros”

  • #7064: 修正 ValueError: 路徑在掛載 ‘X:’ 上,啟動在掛載 ‘D:’ 上…

  • #7067: TST: 修正 Windows 上的 PermissionError: [Errno 13] 拒絕存取

  • #7068: TST: 修正 UnboundLocalError: 參考了區域變數 ‘data’…

  • #7069: 修正 OverflowError: Python int 太大而無法轉換為 C long…

  • #7071: TST: 消除 stats.spearmanr 的 nan 測試的 RuntimeWarning

  • #7072: 修正 OverflowError: Python int 太大而無法轉換為 C long…

  • #7084: TST: linalg: 提高 test_falker 中的容忍度

  • #7095: TST: linalg: 提高 test_falker 中更多的容忍度

  • #7101: TST: 放寬 solve_continuous_are 測試案例 2 和 12

  • #7106: BUG: 停止 cdist “correlation” 修改輸入

  • #7116: 回溯移植到 0.19.0rc2