SciPy 1.5.0 發行說明#
SciPy 1.5.0 是 6 個月辛勤工作的成果。它包含許多新功能、大量的錯誤修復、改進的測試覆蓋率和更好的文檔。此版本中有許多棄用和 API 變更,如下文所述。鼓勵所有用戶升級到此版本,因為其中有大量的錯誤修復和優化。在升級之前,我們建議用戶檢查他們自己的程式碼是否使用了已棄用的 SciPy 功能(要做到這一點,請使用 python -Wd
執行您的程式碼,並檢查 DeprecationWarning
)。我們的開發重心現在將轉移到 1.5.x 分支上的錯誤修復版本,以及在主分支上添加新功能。
此版本需要 Python 3.6+ 和 NumPy 1.14.5 或更高版本。
對於在 PyPy 上運行,需要 PyPy3 6.0+ 和 NumPy 1.15.0。
此版本的重點#
現在
scipy.linalg.lapack
中提供了十幾個以上新的LAPACK
例程的包裝器改進了對利用線性代數後端的 64 位元整數大小的支援
新增了雙尾單樣本 Kolmogorov-Smirnov 檢定的機率分佈
新功能#
scipy.cluster
改善#
使用 minit="++"
初始化 scipy.cluster.vq.kmeans2
在樣本數量上具有二次複雜度。它已得到改進,從而實現了更快的初始化和準線性複雜度。
scipy.cluster.hierarchy.dendrogram
現在遵循 matplotlib
色彩調色盤
scipy.fft
改善#
在這個模組的所有 FFT 函數中新增了一個新的僅限關鍵字參數 plan
。它保留用於從提供 FFT 後端的函式庫(例如 PyFFTW
和 mkl-fft
)傳入預先計算的計畫,目前在 SciPy 中未使用。
scipy.integrate
改善#
scipy.interpolate
改善#
scipy.io
改善#
scipy.io.wavfile
錯誤訊息更明確地說明了問題所在,並且忽略了檔案末尾多餘的位元組,而不是在成功讀取資料後引發錯誤。
scipy.io.loadmat
獲得了一個 simplify_cells
參數,如果設定為 True
,如果 .mat
檔案包含儲存格陣列,則簡化傳回值的結構。
pathlib.Path
物件現在在 scipy.io
Matrix Market I/O 函數中受到支援
scipy.linalg
改善#
scipy.linalg.eigh
已得到改進。現在可以隨意選擇各種 LAPACK
驅動程式,並且可以透過 subset_by_value
關鍵字請求特徵值的子集。引入了另一個關鍵字 subset_by_index
。關鍵字 turbo
和 eigvals
已被棄用。
同樣,標準和廣義 Hermitian 特徵值 LAPACK
例程 ?<sy/he>evx
已新增,現有的例程現在具有完整的 _lwork
對應項。
以下 LAPACK
例程的包裝器已新增到 scipy.linalg.lapack
?getc2
:計算具有完整的一般矩陣的 LU 分解樞軸
?gesc2
:解決給定來自?getc2
的 LU 分解的線性系統?gejsv
:計算一般矩陣的奇異值分解以更高的精度計算微小的奇異值及其對應的奇異向量
?geqrfp
:計算具有一般矩陣的 QR 分解R 對角線上的非負元素
?gtsvx
:使用一般三對角矩陣求解線性系統?gttrf
:計算三對角矩陣的 LU 分解?gttrs
:解決給定來自?gttrf
的 LU 分解的線性系統?ptsvx
:使用對稱正定求解線性系統三對角矩陣
?pttrf
:計算對稱正定的 LU 分解三對角矩陣
?pttrs
:解決給定來自?pttrf
的 LU 分解的線性系統?pteqr
:計算正定的特徵向量和特徵值三對角矩陣
?tbtrs
:使用三角帶狀矩陣求解線性系統?csd
:計算正交/酉的餘弦正弦分解矩陣
廣義 QR 分解例程 (?geqrf
) 現在具有完整的 _lwork
對應項。
已新增酉矩陣的 scipy.linalg.cossin
餘弦正弦分解。
新增了計算 Khatri-Rao 乘積的函數 scipy.linalg.khatri_rao
。
新的函數 scipy.linalg.convolution_matrix
構造表示一維卷積的 Toeplitz 矩陣。
scipy.ndimage
改善#
scipy.optimize
改善#
在各種使用梯度的 minimize
方法中使用的有限差分數值微分具有多個新功能
可以使用 2 點、3 點或複步有限差分。以前只有 2 步有限差分可用。
現在可以使用相對步長,以前只有絕對步長可用。
如果
minimize
方法使用邊界,則數值微分嚴格遵守這些限制。數值微分機制現在使用簡單的快取,在某些情況下可以減少函數評估的次數。
minimize
的method= 'powell'
現在支援簡單的邊界約束
對 scipy.optimize.linprog
進行了多項改進
linprog
基準測試套件已大幅擴展。linprog
基於密集樞軸的冗餘消除例程和稀疏預處理更快當
scikit-sparse
可用時,使用method='interior-point'
解決稀疏問題會更快
當最佳化同時傳回值和梯度的函數時,值的快取已得到改進,避免了在使用 HessianApproximation
(例如 BFGS
)時重複的函數評估。
differential_evolution
現在可以使用現代 np.random.Generator
以及舊版 np.random.RandomState
作為種子。
scipy.signal
改善#
在這個模組的 freqz
函數中新增了一個新的可選參數 include_nyquist
。它用於包含最後一個頻率(奈奎斯特頻率)。
scipy.signal.find_peaks_cwt
現在接受一個 window_size
參數,用於計算雜訊底的視窗大小。
scipy.sparse
改善#
當使用 2d 列向量選擇列索引時,外部索引現在更快。
scipy.sparse.lil.tocsr 更快
修復/改進了 pydata 稀疏陣列和稀疏矩陣之間的比較
BSR 格式稀疏乘法效能已得到改進。
scipy.sparse.linalg.LinearOperator
已獲得新的 ndim
類別屬性
scipy.spatial
改善#
已新增 scipy.spatial.geometric_slerp
,以在 n 球體上實現幾何球面線性內插
scipy.spatial.SphericalVoronoi
現在支援計算 2D 和 3D 案例中的區域面積
cKDTree
使用的樹狀結構建構演算法已從二次最壞情況時間複雜度改進為對數線性。基準測試現在也可用於建構和查詢平衡/不平衡 kd 樹。
scipy.special
改善#
以下函數現在在 cython_special 中具有 Cython 介面
已新增 scipy.special.log_softmax
以計算 softmax 函數的對數。與 log(scipy.special.softmax(x))
相比,它可以為使 softmax 飽和的輸入提供更好的準確性。
scipy.stats
改善#
已改進 scipy.stats.dlaplace
中產生隨機樣本的函數。新函數的速度大約快兩倍,並且記憶體佔用量減少了 25% 到 60% 之間(請參閱 gh-11069)。
scipy.stats
接受種子以使用隨機數字產生(例如,來自分佈的隨機變量)進行可重現計算的函數現在可以使用現代 np.random.Generator
以及舊版 np.random.RandomState
作為種子。
已將 axis
參數新增到 scipy.stats.rankdata
。這允許沿給定軸獨立排列陣列切片的等級。
已將 axis
參數新增到 scipy.stats.f_oneway
,使其能夠為儲存在 n 維陣列中的資料計算多個單向變異數分析檢定。f_oneway
的效能也在某些情況下得到了改進。
stats.geninvgauss
的 PDF 和 CDF 方法現在顯著加快,因為計算 CDF 的數值積分使用了基於 Cython 的 LowLevelCallable
。
常態分佈 (scipy.stats.norm
) 的動差現在使用分析公式而不是數值積分計算,以提高速度和準確性
梯形分佈 (scipy.stats.trapz
) 的動差和熵現在使用分析公式而不是數值積分計算,以提高速度和準確性
截斷常態分佈 (scipy.stats.truncnorm
) 的方法,尤其是 _rvs
,在完全重寫後顯著加快。
Laplace 分佈的 fit 方法 scipy.stats.laplace
現在使用分析公式來計算參數的最大似然估計值。
現在,所有 SciPy 分佈的隨機變量產生都是執行緒安全的。第三方分佈可能需要修改 _rvs()
方法的簽章,以符合 _rvs(self, ..., size=None, random_state=None)
。(當使用不符合規範的分佈時,會發出一次 VisibleDeprecationWarning。)
新增了 Kolmogorov-Smirnov 雙尾檢定統計分佈 (scipy.stats.kstwo
)。使用精確和漸近演算法的混合,計算大小為 n 的樣本的 K-S 雙尾統計量 D_n
的分佈。
新函數 median_abs_deviation
取代了已棄用的 median_absolute_deviation
。
wilcoxon
函數現在使用長度最大為 25 的輸入的精確分佈來計算 Wilcoxon 符號等級檢定的 p 值。該函數有一個新的 mode
參數,用於指定如何計算 p 值。預設值為 "auto"
,對於長度最大為 25 的輸入,它使用精確分佈,而對於較大的輸入,它使用常態近似。
新增了基於 Cython 的新實作來評估高斯核估計值,這應能提高 gaussian_kde
的效能
winsorize
函數現在具有 nan_policy
參數,用於精細處理 nan
輸入值。
使用 statistic="std"
的 binned_statistic_dd
函數的效能提高了約 4 倍。
scipy.stats.kstest(rvs, cdf,...)
現在處理單樣本和雙樣本檢定。單樣本變體使用 scipy.stats.ksone
(或 scipy.stats.kstwo
,後退到 scipy.stats.kstwobign
)來計算 p 值。雙樣本變體(如果 cdf
是類陣列)使用 Hodges 描述的演算法直接計算機率,僅在溢位的情況下後退到 scipy.stats.kstwo
。在兩種情況下,結果都是更準確的 p 值,尤其是在較小(或非常不同)大小的雙樣本檢定中。
scipy.stats.maxwell
效能改進包括 fit()
速度提高 20%,pdf()
速度提高 5%
scipy.stats.shapiro
和 scipy.stats.jarque_bera
現在傳回一個具名元組,以提高與其他 stats
函數的一致性
已棄用的功能#
scipy
已棄用項目#
scipy.special
變更#
bdtr
、bdtrc
和 bdtri
函數正在棄用非負非整數 n
參數。
scipy.stats
變更#
函式 median_absolute_deviation
已過時。請改用 median_abs_deviation
。
字串 "raw"
與 iqr
的 scale
參數搭配使用已過時。請改用 scale=1
。
向後不相容的變更#
scipy.interpolate
的變更#
scipy.linalg
的變更#
?syevr
、?heevr
的輸出簽名已從 w, v, info
變更為 w, v, m, isuppz, info
<sy/he>{gv, gvd, gvx}
的輸出引數 w
、v
的順序已交換。
scipy.signal
的變更#
scipy.signal.upfirdn
的輸出長度已修正,對於某些升/降採樣率以及輸入訊號和濾波器長度的組合,產生的輸出現在可能會更短。
scipy.signal.resample
現在支援 domain
關鍵字引數,用於指定時域或頻域輸入。
scipy.stats
的變更#
其他變更#
改善了在 SciPy 程式碼庫的多個部分中,利用來自線性代數後端的 64 位元整數大小的支援。
為確保 SciPy 與 Python 2.7 相容而設計的墊片 (shims) 現在已移除。
許多因未使用匯入和未使用賦值而產生的警告已獲得解決。
許多使用範例已新增至函式的文件字串 (docstrings) 中,並且在整個程式碼庫中新增了許多輸入驗證和直觀的例外訊息。
在程式碼庫的少數部分中,初步採用了類型註釋 (type annotations)。
針對 1.5.0 版已關閉的議題#
#1455: ellipord does returns bogus values if gstop or gpass are negative…
#1968: correlate2d’s output does not agree with correlate’s output in…
#2744: BUG: optimize: ‘**kw’ argument of ‘newton_krylov’ is not documented
#4755: TypeError: data type “<i0” not understood
#4921: scipy.optimize maxiter option not working as expected
#5144: RuntimeWarning on csgraph.shortest_path when edge lengths are…
#5309: Documentation of ‘hybr’ and ‘lm’ inconsistent in optimize.root
#6026: Replace approx_grad with _numdiff.approx_derivative in scipy.optimize
#6502: Computing Eigenvalues in an Interval with LAPACK
#7058: Errors in special.bdtri and special.bdtr for non-integer k values
#7700: SuperLU does not respect perm_c=”NATURAL”
#7895: Improvements to io.loadmat
#8205: ValueError in scipy.linalg.eigvalsh for large matrix
#8278: Memory limit for scipy.sparse.linalg.spsolve with scikit-umfpack
#8327: scipy.stats.mstats.winsorize NaN handling
#8341: scipy.stats.ks_2samp for masked and unmasked data give different…
#8748: scipy.stats.kstest for same distribution: p-values nonuniform
#9042: optimize: Incorrect statement about `jac` in the `minimize`…
#9197: problem with scipy.signal.butter with 1000+ points array
#9212: EIGH very very slow –> suggesting an easy fix
#9553: ndimage routines behave badly when output has memory overlap…
#9632: ndimage.maximum_filter undocumented behaviour using footprint…
#9658: `scipy.optimize.minimize(method=’COBYLA’)` not threadsafe
#9710: stats.weightedtau([1], [1.0]) SEGFAULTs
#9797: Master Tracker for some Kolmogorov-Smirnov test Issues
#9844: scipy.signal.upfirdn gives different length matrix versus MATLAB…
#9872: scipy.signal.convolve is slower when vectorized
#9913: BUG: No dt in StateSpace operations
#10014: Distribution names `weibull_min`and `weibull_max` should…
#10159: BUG: stats: chisquare returns incorrect results for arrays of…
#10302: scipy.fft: Add a `plan` argument
#10332: ‘Incomplete wav chunk’ inconsistent/reason unknown
#10441: Remove uses of `numpy.dual`?
#10558: Document implicit sum in csr_matrix() constructor
#10788: LU with full pivoting
#10841: Unexpected behavior in linalg.blas.dtrmm wrapper
#10919: optimize._lbfgsb setulb() function violates parameter bounds
#10963: kstest, ks_2samp: confusing `mode` argument descriptions
#11022: Unexpected Result in factorial function with NaN input
#11028: Documentation error in optimize.minimize
#11058: Adding logsoftmax function
#11076: ValueError: Unknown wave file format
#11090: Misconception of the median absolute deviation in stats?
#11095: BUG: find_peaks_cwt test failures in 32-bit Linux wheels
#11107: scipy.io.mmread generated an error “TypeError: startswith first…
#11123: Add wrapper for ?gttrf/?gttrs
#11128: OverflowError in resample_poly (upfirdn)
#11132: Possible bug: rv_discret.ppf for percentiles 0 and 100 and loc…
#11163: Comparisons between scipy spmatrix and can sparse.SparseArray…
#11168: Generalized Pareto variance inaccurate for concentrations near…
#11169: Add wrapper for ?geqrfp
#11184: 2-sided Kolmogorov Smirnov returns p-value of 1
#11185: The .roots() or solve() function of scipy.interpolate.CubicHermiteSpline…
#11190: Add wrapper for ?tbtrs
#11200: Can no longer slice csr_matrix in 1.3.0
#11207: _minimize_scalar_bounded: reference before assignment
#11216: linprog: interior-point: Cholmod reordering can be reused
#11223: Add wrappers for ?pttrf, ?pttrs
#11224: Add wrapperfor ?pteqr
#11235: MAINT: Missleading Error Message for IIR Filter
#11244: Missing reference in `scipy.optimize.line_search`
#11262: Hermitian Eigenvalue Problem eigh() API and wrapper change proposal
#11266: Sparse matrix constructor data type detection changes on Numpy…
#11270: CI failing: Travis CI Py36 refguide and Linux_Python_36_32bit_full…
#11279: linalg.eigh checks whole array for finite values
#11295: CI: azure does not auto-cancel old jobs on pushes
#11299: stats.truncnorm.rvs 100x slower in v1.4.x than v1.3.3
#11315: BUG: special: rgamma on negative integers smaller -34
#11319: Missing `int64_t` declaration in rectangular_lsap.cpp
#11323: Compilation failure due to missing symbol pthread_atfork
#11332: BUG: directed_hausdorff distance on sets u and v when u is a…
#11350: Khatri-Rao product
#11354: ENH: Add wrapper for ?gejsv
#11361: Dropped NaN in eval_genlaguerre function
#11363: Dropped NaN in hyperu function
#11365: scipy.stats.binned_statistic regressed in v1.4.0
#11369: Dropped NaN in eval_hermite
#11370: Dropped NaN in eval_gegenbauer
#11373: Add wrapper for ?gtsvx
#11374: Add wrapper for ?ptsvx
#11391: csgraph.minimum_spanning_tree loses precision
#11398: Update stats to cope with `np.random.Generator` machinery
#11412: Array copying causes unwanted type casting from complex to float…
#11415: Where is the Wiener Filter derived from?
#11416: _lib._util.getargspec_no_self is missing KEYWORD_ONLY support
#11428: Documentation on SHGO inequality constraints appears contradictory
#11429: Add LAPACK’s ZUNCSD cosine sine decomposition
#11438: run_dualannealing passes bounds incorrectly in benchmarks/optimize.py
#11441: Can’t run optimize benchmarks
#11442: Chebyshev weights
#11448: Wrongly typed comparison in integrate.quad
#11458: BUG: maximum_bipartite_matching produces infeasible solution
#11460: CI failing: 2 Travis CI tests fail with numpy build or version…
#11462: Bug on “++” initialization on “kmeans2”
#11464: Shouldn’t data type of KDE evaluation should be like in the input…
#11468: performance of binned_statistics_2d 100x slowdown from 1.3.2…
#11484: Callback function doesn’t give the same value as the one being…
#11492: Confusing dendrogram labelling
#11493: scipy.optimize.least_squares fails if the return array of the…
#11494: Error performing kronecker product between large sparse vectors
#11503: medfilt produces 0 on input of length 1
#11529: Pyflakes generates almost 700 warnings.
#11566: irfft/irfft2/irfftn docs are slightly confusing re: input type.
#11572: least_squares: too small tolerances not catched with method=’lm’
#11581: DOC: scipy.interpolate.RectSphereBivariateSpline
#11586: Differential evolution breaks with LinearConstraints with sparse…
#11595: scipy.spatial.cKDTree construction slow for some datasets
#11598: output of special.voigt_profile when sigma=0
#11601: linalg tests failing in runtests.py
#11602: scipy.optimize.linear_sum_assignment returns reverse diagonal…
#11610: Analytic formula for normal moments
#11611: Build failure with gfortran 10
#11613: TST, MAINT: test_quadpack TestCtypesQuad wasn’t fully migrated…
#11630: SmoothBivariateSpline bbox parameter
#11635: typo in docstring of scipy.stats.norminvgauss
#11637: BUG: core dumps when calling scipy.interpolate.interp1d with…
#11638: better documentation for ‘return_all’ option in minimize(Nelder…
#11652: TST, MAINT: CI failures for pre-release NumPy wheels
#11659: optimize.fmin_l_bfgs_b needs bound check and appropiate error…
#11660: BUG/ENH: distribution.ncf with nc=0 returns nan
#11661: scipy.ndimage.convolve1d and correlate1d don’t behave properly…
#11669: p-value varies with the order of the data
#11676: documentation of scipy.spatial.HalfspaceIntersection: wrong method…
#11685: Rotation cannot be expressed as matrix
#11686: MAINT: mypy imports of Cython “modules”
#11693: TestDifferentialEvolutionSolver::test_L4 failing in CI
#11696: DOC: incorrect compiler information for macOS in docs
#11709: eigh() tests fail to pass, crash Python with seemingly ramdom…
#11763: Small error in gamma continuous rv fit comments
#11769: truncnorm.rvs Weird Behaviors
#11770: crash in TestEigh::test_value_subsets
#11795: trapz distribution mean computed using single precision
#11800: Segmentation fault in scipy.odr for multidimensional independent…
#11811: pyflakes silently failing on travis-ci
#11826: Error with _fblas
#11827: `fft.tests.test_numpy.test_multiprocess` hangs on Python3.8…
#11835: tests with `multiprocessing` hang on Python 3.8 on macOS
#11839: linalg.expm returns nans with RuntimeWarning: overflow encountered…
#11856: Documentation of fit methods for `weibull_min` and `exponweib`…
#11868: Function always evaluated twice when using HessianUpdateStrategy…
#11875: Typo in the docstring of simps()
#11877: kmeans2 ‘++’ method is orders of magnitude slower than sklearn.cluster.KMeans()
#11884: The upper code lines are dead code
#11886: Array shape mismatch in scipy.optimize
#11892: BUG: stats: Incorrect handling of edges cases by ttest_rel and…
#11908: LinearOperator should have ndim attribute
#11910: Documentation missing for what M is in init argument
#11922: macOS actions CI has started failing in last couple of days.
#11928: DOC: signal: Wrong description for sepfir2d, cspline2d, qspline2d
#11944: curve_fit documentation unclear on default value of absolute_sigma
#11945: Add a (potentially temporary) py.typed file?
#11949: ValueError ‘k exceeds matrix dimensions’ for sparse.diagonal()…
#11951: BUG: asv benchmark failed because of cython version
#11967: BLD: Azure windows runs complain about drives
#11973: oaconvolve(a,b,’same’) differs in shape from convolve(a,b,’same’)…
#12002: pybind11 license
#12003: MAINT: circular SphericalVoronoi input
#12015: Reordering of CSC matrix breaks when you go above int32 limits
#12031: Documentation Rendering Issues Visible in CircleCI Artifacts
#12037: MAINT, CI: new Cython 3.0a4 issue
#12087: DOC: some odr models are missing docs
#12119: signal.fftconvolve no longer convolves types f8 and numpy.float64
#12149: Documentation of Rosenbrock function
#12173: Large memory usage when indexing sparse matrices with `np.ix_`
#12178: BUG: stats: Some discrete distributions don’t accept lists of…
#12220: BUG, REL: gh_lists.py compromised scraping
#12239: BUG: median absolute deviation handling of nan
#12301: integer overflow in scipy.sparse.sputils.check_shape when matrix size > 2^32
#12314: scipy.spatial.transform.Rotation multiplication does not normalize quaternion
針對 1.5.0 版的 Pull Requests#
#6510: Add Eigenvalue Range Functionality for Symmetric Eigenvalue Problems
#9525: BUG: SuperLU ‘NATURAL’ order applies a column permutation
#9634: Add the number of Jacobian evaluations to the output of L-BFGS-B.
#9719: ENH: Added kstwo probability distribution for two-sided one-sample…
#9783: WIP: optimize: added (dense) interpolative decomposition redundancy…
#10053: Adding docstring to weibull_min and weibull_max based on issue…
#10136: DEP: Add warning to linprog_verbose_callback
#10380: ENH: add geometric_slerp
#10602: MAINT: optimize: refactor common linprog arguments into namedtuple
#10648: Bounds for the Powell minimization method
#10673: ENH: approx_fprime –> approx_derivative
#10759: ENH: calculation of region areas in spatial.SphericalVoronoi
#10762: BENCH: optimize: more comprehensive linprog benchmarking
#10796: ENH exact p-values of wilcoxon test in scipy.stats
#10797: ENH: linalg: LU with full pivoting (wrappers for ?getc2/?gesc2)
#10824: ENH: Fast gaussian kernel estimator
#10942: BUG: prevent bound violation in L-BFGS-B optimize method
#11003: ENH: add scipy.linalg.convolution_matrix
#11023: improving error message for cubic-interpolate with duplicates
#11045: MAINT: make bdt{r,rc,ri}() functions accept double n,k args +…
#11063: Fix documentation error in optimize.minimize
#11069: ENH: stats.dlaplace.rvs improvements
#11071: DOC: Added examples to maximum_position in ndimage
#11075: DOC: Update stylistic consistency in multiple files
#11097: BUG: stats: fixing chisquare to return correct results for arrays…
#11110: ENH: special: Cythonise erfinv, erfcinv
#11112: BUG: special: Return NaN outside the domain of `eval_hermite`
#11114: BUG: special: fix `hyp1f1` for nonnegative integral `a` and…
#11115: DOC: special: add docstrings for `kei`, `ker`, `keip`,…
#11130: ENH: support for circular input
#11136: BUG: expm handling of empty input
#11138: DOC: stylistic consistency, punctuation, etc.
#11139: MAINT: cluster: use cython_blas, remove handwritten BLAS wrappers
#11146: DOC: update docs on bp parameter for detrend
#11151: DOC: special: add docstrings for `bei`, `ber`, `beip`,…
#11156: ENH: add input validation for ellipord.
#11157: DOC: stylistic revision, punctuation, consistency
#11160: ignore warning on 0 * inf in basin hopping
#11162: DOC: minor stylistic revision, undo changes
#11164: ENH/ BUG: Pydata sparse equality
#11171: Fix dtype validation of “seuclidean” metric V parameter
#11177: BUG: stats: Improve genpareto stats calculations.
#11180: MAINT: stats: Some clean up in test_distributions.py.
#11187: ENH: add functionality log_softmax to SciPy.special.
#11188: MAINT: add rvs method to argus in scipy.stats
#11196: DOC: special: add to docstrings of Kelvin zeros functions
#11202: BUG: fix edge counting in shortest_path
#11218: BUG: scipy/interpolate: fix PPoly/Cubic*Spline roots() extrapolation…
#11225: Add a warning to constant input for spearmanr() function
#11226: Speed up of interior-point method for cholesky solver
#11229: BUG:_upfirdn.py 中明確的 dtype 規格
#11230: 為 optimize 教學新增引用文獻
#11231: 為重複的 f-evals 新增 SLSQP 測試 (#10738)
#11236: MAINT:改進 iirfilter 中 Wn 範圍的錯誤訊息。
#11245: ENH:optimize:密集冗餘移除常式最佳化
#11247: MAINT:移除 _lib/_numpy_compat.py
#11248: BUG:rv_discrete.ppf() 處理 loc
#11251: DOC:為 linesearch zoom 演算法新增參考文獻
#11253: BUG:修復 kendalltau 問題,其中 p-value 會變成 >1
#11254: MAINT:使 special.factorial 正確處理 nan
#11256: DOC:更新 scipy.linalg.qr 的文件
#11265: 修復:在 1.3.0 中無法再切片 csr_matrix
#11267: BUG:重新設計 ks_2samp 雙尾精確檢定中的縮放。
#11268: DOC:NonLinearConstraint 的範例
#11269: 修復:稀疏矩陣建構函式資料類型偵測在…上變更
#11276: BLD:更新最低 Python、NumPy、Cython、Pybind11 版本
#11277: MAINT:清除不支援的 numpy 版本的條件式
#11278: MAINT:清除 stats.iqr 對於不支援的 NumPy 版本的變通方法
#11282: TST/CI:改進測試失敗的回溯格式
#11284: 修復 ndimage 濾波器中模式序列的文件與行為
#11285: DOC:special:完成卡方函數的 docstring
#11286: BUG:使 loadmat/savemat 檔案開啟正確關閉資源
#11287: CI:在合併和直接推送時跳過 Azure 和 TravisCI 建置…
#11288: DOC:修復 scipy.io.wavfile.read 範例程式碼中的 import
#11289: BUG:為 open 使用 context manager
#11290: MAINT:移除 _lib._version,改用 _lib._pep440
#11292: DOC:special:為各種便利函數新增 docstring
#11293: DOC:special:修復 `chdtri` docstring 中的錯字
#11296: DOC:special:新增至 Bessel 零點和導數的 docstring
#11297: DOC:special:為 Bessel 積分新增參數/回傳值章節
#11300: MAINT:更新 vendored uarray 版本
#11301: CI:azure 條件應要求 succeeded()
#11302: ENH:為 ILP64 BLAS + ARPACK 轉換建置基礎架構
#11303: DOC:special:修復 `besselpoly` docstring 中的錯字
#11304: ENH:MAINT:重寫 eigh() 和相關的 wrappers
#11306: TST:跳過在 ppcle64 上崩潰的 test_aligned_mem linalg 測試
#11307: MAINT:修復錯字 ‘solutuion’ -> ‘solution’
#11308: ENH:不要從純量建立 1d 陣列
#11310: MAINT:清理物件陣列建立、純量/1d 混淆
#11311: DOC:在 cluster.hierarchy.fclusterdata 中指定度量的自訂可呼叫選項
#11316: BUG:special:修復 `rgamma` 零點的行為
#11317: BUG:修復 C99 下的浮點文字比較
#11318: TST:optimize:標記兩個 linprog 測試以跳過
#11320: BUG:在 `rectangular_lsap.cpp` 中包含 `int64_t` 宣告
#11330: MAINT:更新 vendored pypocketfft 版本
#11333: BUG:directed_hausdorff 子集修復
#11335: [ENH] sparse:放寬稀疏外部索引快速路徑的檢查
#11337: pavement.py 中未定義的名稱 ‘e’
#11338: scipyoptdoc.py:移除未使用的變數 ‘sixu’
#11340: xrange() 已在 Python 3 中移除,改用 range()
#11342: range() 已在 Py3 的 _binned_statistic.py 中移除
#11343: BUG:constants:修復 ‘exact’ 值表
#11347: ENH:新增輸入驗證函數並將其應用於需要的函數
#11348: MAINT:移除 six.string_types 用法
#11349: MAINT:_minimize_trustregion_constr 的小文件修復
#11353: MAINT:py3 移除各種 six 用法
#11358: ENH:optimize:使用 CSR 格式而非 LIL 以提高速度
#11362: MAINT:sys.version_info >= 3.5
#11364: ENH:為 f_oneway 快取平方和
#11368: ENH:為 freqz() 新增可選參數 “include_nyquist”
#11372: BENCH:optimize:為 linprog 新增 presolve 基準測試
#11376: ENH:為 ?gttrf/?gttrs 新增 wrapper
#11377: MAINT:從 tools/authors.py 移除 Python 2 程式碼
#11378: ENH (WIP):?tbtrs 的 Python wrapper
#11379: MAINT:從 benchmarks/cython_special.py 移除 six.with_metaclass
#11380: BUG:sparse/isolve:bicg 和 qmr 未正確處理 x0
#11382: MAINT:移除 binned_statistic_dd() 在非有限值上的錯誤拋出…
#11383: MAINT:_lib:移除 getargspec 中的 py2 相容性墊片
#11384: MAINT:直接使用 numpy 純量類型
#11385: ENH:special:將球面 Bessel 函數新增至 `cython_special`
#11389: MAINT:line.startswith 不應為 bytes
#11393: ENH:加速 truncnorm 的 ppf() 和 rvs() 方法
#11394: MAINT:從 stats 移除 self._size (和 self._random_state)…
#11395: 錯誤訊息中的更正 (%d->%g 格式)
#11396: DOC:還原 gh10540,移除 mtrand
#11397: MAINT:differential_evolution 接受 np.random.Generator
#11402: ENH:stats 可以使用 np.random.Generator
#11404: ENH:為 butter() 新增 docstring,以解決傳遞函數語法問題
#11405: DOC:修復 SmoothBivariateSpline 的 “另請參閱”
#11408: ENH:在 `scipy.fft` 中的 FFT 函數新增 `plan` 參數
#11411: MAINT:檢查 minimize 重複評估
#11418: ENH:Linalg:?geqrfp 的 Python wrapper
#11419: TST:Python 3.7 mac OS gcc multibuild 修復
#11423: ENH:新增工具以 lint diffs
#11425: FIX:_array_newton 應保留複數輸入
#11426: MAINT:全域最佳化基準測試的授權
#11431: 使 median_absolute_deviation scale 參數與 iqr 對齊
#11432: 修復錯誤訊息錯字
#11433: DOC:從 longs 移除 L
#11434: MAINT:Python3 改進 refguide_check.py
#11435: DOC:更新 runtest –parallel 說明
#11436: MAINT:移除 sys.version < 3.5 的檢查
#11437: DOC:修復文件問題
#11439: 在 mmio 函數中支援路徑物件 (PEP 519)
#11440: 為 benchmarks/optimize.py 中的 run_dualannealing 更正 bounds 傳遞
#11443: BENCH:optimize_linprog 移除 ImportError 例外
#11453: BUG:sparse:根據需要將 csc/csr 索引轉換為 int64
#11454: DOC:移除 `maximum_bipartite_matching` 的警告
#11455: BUG:修復 _lib._util.getargspec_no_self 缺少 KEYWORD_ONLY 支援的問題。
#11456: khatri_rao 乘積的實作
#11459: BUG:修復 maximum_bipartite_matching 中增強功能損壞的問題
#11461: MAINT:SciPy.sparse.linalg.arpack 註解中的小拼字更正
#11467: [MRG] 使 KDE 評估的結果資料類型與輸入類似…
#11469: 更新 integrate.quad 文件
#11472: 修復結果錯字
#11476: DOC:stats:複製編輯 anderson docstring。
#11478: ENH:避免矩陣乘積中不必要的陣列複製
#11481: BUG:使 special.hyperu 在任何引數為 nan 時回傳 nan
#11483: BUG:修復 `scipy.cluster.vq` 上 `_kpp` 初始化,關閉…
#11485: ENH:更新 KrylovJacobian 類別的 docstring 以修復 #2744
#11486: BUG:使 special.eval_hermite 在第二個引數為 nan 時回傳 nan…
#11487: ENH:改進 correlate 和 correlate2d 的 docstring 以修復 #1968
#11488: FIX:變更 scipy.optimize _root.py 的 “func -> fun” 以解決…
#11489: BUG:修復 PR #11253 在 stats.mstats.kendalltau() 中引入的錯字
#11490: DOC:修復 scipy/io/matlab/mio4.py 中的錯字
#11495: MAINT:重構 slsqp 以修復 callback 函數中的問題
#11498: [DOC] 在最大流量 docstring 中提及圖割
#11499: DOC:改進 scipy.signal.signaltools.wiener 的文件
#11506: DOC:修復 scipy.stats.morestats 文件中的錯字
#11508: ENH:在給定 dtype 時,避免在稀疏 __init__ 上複製
#11509: ENH:避免矩陣乘積中不必要的陣列複製 (再次)
#11510: [DOC] 建立任意大小三對角矩陣的範例
#11511: TST:為 Travis/sparse 固定 numba 版本
#11513: TST:停用 NumPy 快取目錄 ppc64le
#11514: BUG:使 special.eval_genlaguerre 在傳遞 nan 時回傳 nan
#11517: ENH:改進 sparse.lil.tocsr 效能
#11519: 修復 fresnel 文件
#11520: BUG:使 special.eval_gegenbauer 在傳遞 nan 時回傳 nan
#11524: ENH:餘弦正弦分解
#11526: BUG:修復 SLSQP 最大迭代次數設定以修復 #4921
#11527: ENH:改進 weibull_min_gen 和 weibull_max_gen 的 docstring…
#11530: MAINT:從 ndimage 移除 3 個未使用的 imports、3 個未使用的 assignments。
#11531: DOC:修復 gh PR 11045 中 bdtr 和 bdtrc 的錯字
#11532: MAINT:修復多個來自…的未使用 imports 和未使用 assignments
#11533: MAINT:修復約 100 個未使用的 imports、未使用 assignment 警告…
#11534: FIX:允許非原生位元組順序輸入至 scipy.fft
#11535: MAINT:修復 _lib 中多個未使用的 imports。
#11536: MAINT:修復多個來自…的未使用 imports 和未使用 assignments
#11537: MAINT:移除 scipy/constants 中未使用的 import。
#11538: MAINT:修復 scipy/fft 中多個未使用的 imports。
#11539: MAINT:修復多個來自…的未使用 imports 和未使用 assignments
#11540: MAINT:修復 scipy/misc 中兩個未使用的 imports。
#11541: MAINT:修復多個來自…的未使用 imports 和未使用 assignments
#11542: MAINT:修復 scipy/odr 中未使用的 import。
#11543: MAINT:修復多個來自…的未使用 imports 和未使用 assignments
#11544: MAINT:修復 scipy/integrate 中未使用的 imports 和未使用 assignments。
#11545: MAINT:移除未使用的 imports 並修復 scipy/integrate 中未使用的 assignments…
#11546: MAINT:移除未使用的 imports;修復 scipy/signal 中未使用的 assignments。
#11547: MAINT:移除未使用的 imports;修復 scipy/spatial 中未使用的 assignments
#11548: MAINT:移除未使用的 imports;修復 scipy.sparse 中未使用的 assignments。
#11549: MAINT:將 xrange 替換為 range
#11560: MAINT:stats:移除 _argcheck 呼叫
#11573: MAINT:移除未使用的 imports;修復 scipy/stats 中未使用的 assignments。
#11574: MAINT:`optimize.nnls` 錯誤訊息的小變更。
#11575: MAINT:更新 sytrd/hetrd 測試
#11582: MAINT:修復 quadpack.py 中的錯字,關閉 #11448
#11585: TST:新增 openblas_support.py
#11587: BUG:具有稀疏 LinearConstraint 的差分進化…
#11588: MAINT:在 lsmr/lsqr 中完整顯示問題大小。
#11589: MAINT:移除 Python 2 變通方法
#11590: MAINT:移除 Python2 模組初始化
#11605: _linprog_util.py 中邊界的標準化
#11608: BUG:修復 DE callback 中 is 的使用
#11614: TST, MAINT:TestCtypesQuad 使用 pytest 跳過
#11619: ENH:為 stats.mstats.winsorize 新增 nan_policy 參數和功能
#11621: MAINT:清理 ndimage 中 PY_VERSION_HEX、NPY_PY3K 的使用
#11622: MAINT:清理 sparse 中 PY_VERSION_HEX、NPY_PY3K 的使用
#11623: MAINT:移除不必要的 ‘from __future__ import …’ 陳述式
#11626: MAINT:清理 PY_VERSION_HEX 的使用
#11627: ENH:為常態動差新增解析公式
#11628: MAINT, TST:調整 azure 以適應 matplotlib 發行
#11631: 還原 `linear_sum_assignment` 中常數成本矩陣的舊行為
#11632: MAINT:使用 DEF 而非 cdef 定義 ARRAY_ANYORDER
#11639: BUG:interpolate/interp1d:在全 nan 輸入上優雅地失敗
#11640: MAINT:修復 BLAS3 trmm wrapper 的 “side” 引數
#11642: TST, MAINT:移除 Travis CI 中的無效程式碼
#11643: MAINT:修復 binom_test 中的轉換
#11645: MAINT:各種清理。
#11646: MAINT:移除不必要的 ‘from __future__ import …’ 陳述式
#11647: DOC:記錄 return_all 引數
#11648: 在四元數空間中執行幾何 slerp
#11651: DOC:更新 lambertw 文件中的論文 URL
#11653: PERF:切換至 C++ STL std::nth_element
#11655: MAINT:移除 Python2 cStringStream
#11657: ENH:為 ?pttrf/?pttrs 新增 wrapper
#11664: ENH:為 ?gejsv 新增 wrapper
#11665: ENH:為 ?pteqr 新增 wrapper
#11667: BUG:非中心 Fisher 分佈 (修復 nc=0 時的 nan 值)
#11668: ENH:為 ?gtsvx 新增 wrapper
#11671: TST, CI:暫時還原 Azure
#11672: 當陣列大小 < kernel_size 時,為 medfilt 新增警告
#11674: TST:提高兩個 np.dot 相關 linalg 測試的測試精確度。
#11675: MAINT:pycodestyle 清理
#11677: ENH:為 ?ptsvx 新增 wrapper
#11679: BENCH:新增 cKDTree 基準測試:平衡/不平衡樹 (相關…
#11680: MAINT:rng_integers 允許 RandomState.randint 或 Generator.integers
#11683: BUG:修復長度為 1 的軸上的 mode=’mirror’
#11684: BUG:修復 scipy.special.voigt_profile
#11687: MAINT:sparse.linalg:避免從 `np.core` 匯入
#11688: ENH:mypy:明確指定忽略遺失的 imports
#11690: MAINT:mypy:修復清單中不相容類型的錯誤
#11692: MAINT:mypy:修復剩餘的類型錯誤
#11694: TST, MAINT:升級至 OpenBLAS 0.3.9 stable,提高 Win 的 tol…
#11697: DOC:修復 scipy.stats 中 norminvgauss 的 pdf
#11701: MAINT:special:為 `_ufuncs` 擴充功能新增基本類型…
#11702: BUG:修復 eigh() 的合併後錯誤
#11703: 使用一致的 L2 範數改進 docstring
#11705: DOC:Slerp SphericalVoronoi docstring
#11706: ENH:mypy:為 `runtests.py` 新增 `–mypy` 選項
#11710: ENH:修改 stats.kstest() 以使用精確的 stats.kstwo.sf()…
#11715: DOC:為 spatial/transf 中的 as_matrix/from_matrix 新增 .. versionadded::
#11716: BENCH:修復 ``optimize_linprog.py`` 的基準測試 imports
#11721: MAINT:io:移除現在不必要的 `# type: ignore`
#11722: MAINT:mypy:從 ratchet 移除 mpmath
#11726: 處理 scipy.stats.f_oneway 的常數輸入
#11729: BENCH:optimize:為 linprog 新增不可行的基準測試
#11731: 修復關於 Mac OS 編譯器的不準確資訊 (#11696)
#11733: 修復 HalfspaceIntersection 的不準確 docstring 範例
#11734: Doc:修復 SmoothBivariateSpline 的不準確 docstring。
#11735: Bug:stats:修復 median_absolute_deviation 對於…的錯誤形狀
#11736: ENH:為 fitpack2.py 中的 FITPACK 新增輸入驗證及其測試
#11737: BUG:防止因 ?heevr 中的 MKL 錯誤而崩潰
#11739: MAINT:special:為 `_test_round.pyx` 新增類型存根
#11740: MAINT:special:移除未使用的 specfun f2py wrappers
#11741: BUG:修復 minpack 的小容差處理並新增測試。
#11743: Doc:修復 rfft、rfft2、rfftn、irfft、irfft2、irfftn 的 docstring…
#11744: MAINT:移除未使用的 py3k.h 程式碼
#11745: DOC:stats:清理 ncf 文件。
#11748: MAINT:special:將 `cython_special` 類型設為 `Any`
#11750: MAINT:`_spherical_voronoi` 的類型提示
#11752: DOC:修復 scipy.optimize.least_squares 的 docstring
#11753: ENH:為 dendrogram 新增輸入驗證和測試。
#11755: MAINT:將 tostring 的用法替換為 tobytes
#11757: ENH:改進 binned_statistics_2d 效能。
#11759: ENH:optimize:為 linprog 新增 HiGHS 方法
#11760: MAINT:移除被 GenericStream 替換的 FileStream
#11761: MAINT:替換 npy_3kcompat.h shims
#11765: TST:加速在 Azure 上非常慢的 test_pascal
#11766: TST:加速 differential_evolution L8 測試
#11767: 變更連續 rv gamma fit 函數中的註解
#11776: 為 resample 新增 domain 選項。
#11784: BUG: 修正 scipy.sparse.random 中非零元素的計算
#11786: ENH: stats: 為 scipy.stats.rankdata 新增 axis 關鍵字參數
#11789: Doc: 修正 scipy.spatial.chebyshev 的文件字串
#11792: DOC: dev: 新增開發公開 Cython API 的指南
#11794: MAINT: 新增註解說明 cython_optimize 組織中的問題
#11796: DOC: 新增關於 csgraph.minimum_spanning_tree… 中精度損失的註記
#11997: ENH: 允許 `interpolate.BSpline` 中使用負 `axis`。並且…
#11998: 為 scipy.io.loadmat 新增 simplify_cells 參數
#11801: MAINT, DOC: scipy.stats 中 ratio-of-uniforms 的小幅變更
#11802: BUG: 修正 scipy.odr 以處理多維獨立及…
#11803: scipy.stats.trapz:使用解析公式計算統計量和熵。
#11808: DOC: 在 scipy.interpolate.interpn 文件字串中新增範例。
#11809: 重複的條目會在 csr_matrix 建構函式中被加總
#11813: MAINT: 將 pyflakes 版本升級至 2.1.1
#11814: BUG: scipy.sparse.csr doctest 因輸出值不正確而失敗
#11817: DOC: 在 scipy.optimize.leastsq 文件字串中新增範例
#11820: ENH: 在 optimize.fmin_l_bfgs_b 中,針對不正確的邊界格式引發錯誤
#11822: CI:為 macOS 新增 github actions
#11824: DOC: 在 scipy.optimize.line_search 文件字串中新增範例 (line_search_wolfe2)
#11830: TST:在 fft 測試中,多進程處理一律使用 fork
#11831: DOC: 在 scipy.misc.central_diff_weights… 中新增範例和傳回值
#11832: DOC: stats: 針對幾個文件字串進行小幅修正。
#11833: BUG: 修正當 flags 中使用路徑時的 compiler_name
#11836: MAINT: 在 Python 3.8 上重新引入多進程測試
#11837: Doc: 在 scipy.optimize.fsolve 文件字串中新增範例
#11838: Doc: 在 scipy.sparse.linalg.minres 文件字串中新增範例
#11840: BUG: sparse.linalg: 修正 expm 中間計算的溢位
#11842: BLD:修正使用 gfortran 10 進行建置
#11843: MAINT: 簡化 constants.py 中的浮點數
#11847: DOC: 新增 scipy.optimize.linprog 的教學
#11849: ENH: 透過使用 cython 加速 geninvgauss
#11852: CI:從 travisCI 移除 osx
#11857: BUG: 將 gausspulse 的參數 fc 變更為 float。
#11861: 樣條函數的 order = degree + 1
#11863: 使 g77 ABI wrapper 能與 gfortran ABI lapack 搭配運作
#11866: MAINT: 為 sympy 和 matplotlib 匯入新增類型忽略
#11867: CI:在 travis-ci 中新增 arm64
#11869: DOC: signal: 在 lsim2 文件字串中新增範例。
#11870: DOC: signal: 在 impulse 範例中使用 impulse 而非 impulse2…
#11871: ENH: 將 special 中的 ufuncs 類型設為 ufuncs 而非 Any
#11872: BUG: 避免在 scipy.optimize.optimize.MemoizeJac 中重新計算
#11873: DOC: signal: 修正 impulse 和 impulse2 文件字串中的 ODE。
#11874: DOC: 為 scipy.interpolate.approximate_taylor_polynomial 的文件字串新增範例
#11878: DOC: 修正 scipy/integrate/quadrature.py 中的錯字
#11879: BUG: 修正 sparse.kron 中的索引陣列溢位
#11880: DOC: stats: 為 bartlett、fligner、levene 新增範例。
#11881: MAINT: 在 optimize.py 中將 numpy–>np 標準化
#11882: DOC: 為 scipy.io.readsav 文件字串新增範例。
#11883: DOC: 為 scipy.ndimage.correlate() 文件字串新增傳回值和範例
#11885: BUG: stats: 在 f_oneway 等函式中處理多維陣列。
#11889: DOC: signal: 統一 lsim 和 lsim2 範例。
#11896: BUG: stats: 修正 ttest_rel 和 ttest_ind 對大小為 0 輸入的處理。
#11897: DOC: 從 fit 方法中移除誤導性的預設值
#11898: MAINT: LinearVectorFunction.J 為 ndarray,關閉 #11886
#11902: BUG: linalg: test_heequb 失敗
#11904: 修正複數輸入和 overwrite_x=True 的實數對實數轉換
#11906: DOC: stats: 修正 trapz 文件字串造成的錯誤
#11907: BUG: stats: 修正 Issue #9710 的 SEGFAULT
#11912: ENH: 在 hierarchy/dendrogram 中採用 matplotlib 色彩配置。
#11914: DOC: 精進 spatial.distance.squareform 的文件
#11915: ENH: N 維線性算子
#11919: ENH: 在 find_peaks_cwt() 中公開 “window_size” 參數
#11920: DOC: 說明 M、diffev
#11923: CI:macOS 安裝 swig,關閉 #11922
#11924: DOC: 為 scipy.optimize.bracket() 文件字串新增範例
#11930: DOC: 為 signal.qspline1d 和 signal.qspline_eval… 新增範例並進行清理
#11931: DOC: 為 sparse.linalg.bicg 文件字串新增範例。
#11933: DOC: 為 Yao-Liu 目標函數新增原始參考文獻
#11934: DOC, MAINT: 更新 mailmap
#11935: DOC: 使 scipy.stats.mode 文件反映該函式…
#11936: ENH: special:為 `orthogonal.py` 新增類型存根
#11937: DOC: 為 fft2、ifft2、io.savemat 新增文件字串範例
#11938: MAINT: 新增輔助函式以棄用 Cython API 函式
#11942: MAINT: 忽略 _lib/_util 中的條件式匯入
#11943: MAINT: special:為 geterr/seterr/errstate 新增類型
#11946: MAINT: 新增 py.typed 標記
#11950: TST:MAINT: 分離並穩定 heequb 測試
#11952: DOC: 更新 py38、C99、C++11/14 的工具鏈藍圖
#11957: MAINT: 使用 np.errstate 上下文管理器取代 np.seterr。
#11958: MAINT: interpolate:移除一些尾隨空格。
#11960: MAINT: 清理 Python 2 相容性程式碼
#11961: MAINT: 從 _superluobject.c 移除 numpy/npy_3kcompat.h
#11962: DOC: 修正 `_vq._vq()` 文件字串中 `codes` 的類型
#11964: MAINT: 清理未使用的 IS_PYPY
#11969: DOC: 為 special.airye 新增範例並修正文件字串
#11970: BUG: sparse:修正稀疏矩陣的 ‘diagonal’ 以符合 numpy 的…
#11974: BUG: 即使未捲積任何軸,仍重塑 oaconvolve 輸出
#11976: MAINT: 為 github actions 新增 logo
#11977: CI:測試 bleeding edge Python
#11979: DOC: 為 stats.ranksums() 文件字串新增範例。
#11982: 修正 KMeans++ 初始化速度緩慢的問題
#11983: DOC: 為 stats.mstats.argstoarray() 文件字串新增範例。
#11986: 避免當輸出和輸入陣列重疊時 ndimage 中出現錯誤…
#11988: ENH: 以最大值覆寫 Laplace 分佈的 fit 方法…
#11993: TST, CI: Azure Windows 路徑修正
#11995: MAINT, CI: 移除自訂 mingw Azure
#11996: DOC: 為 fft.set_global_backend… 新增範例並修正 pep 警告
#11997: MAINT, CI: Azure OpenBLAS 簡化
#11998: BENCH:針對目前的 HEAD 而非 master 執行
#12001: ENH: stats:為 maxwell 分佈實作 _logpdf。
#12004: DOC: 為 integrate.quad_vec() 和 integrate.quad_explain() 新增範例
#12005: MAINT: 在 ?tbtrs 測試中使用輔助函式
#12007: MAINT: 更新 pybind11 和 six 的 LICENSES_bundled
#12008: DOC: 藍圖更新
#12009: ENH: optimize:在 lbfgsb 中支援 64 位元 BLAS
#12010: ENH: sparse.linalg:在 isolve 中支援 64 位元 BLAS
#12012: DOC: 為 interpolate.barycentric_interpolate()… 新增範例
#12013: MAINT: 移除 numpy.dual 的最後使用
#12014: CI:列印 10 個最慢的測試
#12020: MAINT: 移除 SphericalVoronoi 中對環狀輸入的處理
#12022: DOC : 在 scipy.optimize.curve_fit 文件中將 absolute_sigma 的預設值新增為 False
#12024: DOC: 為 io.hb_read() 和 io.hb_write() 新增範例
#12025: MAINT: 從 nd_image 移除 numpy/npy_3kcompat.h
#12028: 拼字修正
#12030: ENH: optimize/_trlib:支援 ILP64 blas/lapack
#12036: MAINT: 為一些產生的 C 檔案新增 .gitignore
#12038: MAINT, CI: Travis rackcdn->conda.org
#12039: MAINT: signal:降低 chirp… 中繪圖的解析度
#12040: DOC: 為 ndimage.spline_filter1d() 和 spline_filter()… 新增範例
#12044: MAINT: 將 apt-get update 和 apt-get install 合併為一個 RUN
#12045: TST:縮減 test_diagonal_types 的大小以加速測試
#12046: MAINT: 移除未使用的 npy_3kcompat.h
#12047: MAINT: Cython 3.0 相容性
#12050: DOC: 在 README.rst 中新增 PyPI 和 conda-forge 的下載次數徽章
#12052: DOC: 新增 odr.models.polynomial() 範例並修正 odr.odr 文件字串…
#12056: ENH: 修改 shapiro 以傳回具名元組
#12057: 將我的名字加入 THANKS.txt
#12060: TST:減少 test_diagonal_types 設定的數量
#12062: TST:將 dec.slow 變更為 pytest.mark.slow
#12068: ENH: 修改 jarque_bera 以傳回具名元組
#12070: MAINT, CI: appveyor rack->conda.org
#12072: TST:過濾 factorial(float) 棄用警告
#12078: TST:在 colab 上跳過記憶體分配量大的測試
#12079: DOC: 從 stats 教學中移除 Python 2 參考
#12081: DOC: 為 optimize.show_options() 新增範例文件字串
#12084: BUG: interpolate:修正 BarycentricInterpolator 與整數輸入…
#12089: ENH: spatial/qhull:支援 ILP64 Lapack
#12090: ENH: integrate:在 odeint/vode/lsoda 中支援 ILP64 BLAS
#12091: ENH: integrate:在 quadpack 中支援 ILP64
#12092: BUG: 修正在 signal.StateSpace 中遺漏 dt 的問題
#12093: MAINT: 回滾 python2.6 變通方案
#12094: MAINT: `openblas_support` 雜湊檢查
#12095: MAINT: ndimage:將 `shares_memory` 變更為 `may_share_memory`
#12098: Doc: 將 4 個 odr 模型實例變更為 `Model` 的實例…
#12101: 移除更多未使用的匯入和賦值。
#12107: ENH: SphericalVoronoi 中 2D 輸入的面積計算
#12108: MAINT: 確保 `SphericalVoronoi` 中屬性具有正確的資料類型
#12109: 樣條函數中 degree 不是 order
#12110: ENH: 更友善/寬容的 io.wavfile 錯誤
#12117: BUG: 修正換行符號
#12123: [MAINT] 修正 PyData/Sparse 匯入時的錯誤。
#12124: TST:既然需要 Python 3.5+,就始終測試 matmul
#12126: TST:清理未使用的 matplotlib 程式碼。
#12127: DOC: 更新 signal.cspline2d、qspline2d、sepfir2d 的文件字串
#12130: MAINT: 使用 linkchecker 修正損壞的連結
#12135: ENH: linalg:新增 convolution_matrix 函式。
#12136: MAINT: 清理 np.poly1d hack
#12137: TST, CI: 重現 wheels 32 位元設定
#12140: TST: stats:將 kstwo、ksone 新增至慢速測試。
#12141: 在 Fitpack 中支援 64 位元整數大小
#12151: DOC: 修正 Rosenbrock 函數總和
#12159: BUG: 修正 upfirdn 中的長度計算
#12160: BUG: 修正 M_PI
#12168: DOC: 新增過時版本檢查 javascript 至文件發佈…
#12171: CI, MAINT: Azure OpenBLAS 磁碟機翻轉
#12172: ENH: Powell 最小化方法的邊界
#12175: BLD: 支援更多 Fortran 編譯器以用於 ilp64 和巨集展開…
#12179: BUG: stats: 少數分佈不接受列表作為引數。
#12180: MAINT: 移除 SphericalVoronoi 測試中多餘的匯入
#12181: DOC: 對於 versionwarning,請勿使用 $.getScript
#12182: MAINT: SphericalVoronoi 中超球體上的隨機取樣…
#12194: MAINT: 文件建置的模組和範例清理
#12202: ENH: 從 Anaconda DL 發佈 wheels 的工具
#12210: 移除 py.typed 標記 (至少針對發佈版本)
#12217: BUG: stats: 修正在 median_abs_deviation 中邊緣案例的處理。
#12223: BUG: stats: wilcoxon 對於特定輸入傳回 p > 1。
#12227: BLD: 建置 rectangular_lsap 時設定 macos 最小版本
#12229: MAINT: tools/gh_lists.py:修正 http 標頭大小寫敏感度問題
#12236: DOC: 修正 1.5.0-notes.rst 中的幾個文法錯誤。
#12276: TST: 跳過 test_heequb,它會間歇性失敗。
#12285: CI:將 travis arm64 執行拆分為兩個
#12317: BUG: 防止 Rotation 乘法中的錯誤累積
#12318: BUG: sparse:避免 np.prod 在 check_shape 中溢位
#12319: BUG: 使 cobyla 成為執行緒安全
#12335: MAINT: 避開 Sphinx 錯誤