Skip to content

Releases: scipy/scipy-stubs

v1.16.0.2

01 Jul 23:18
v1.16.0.2
d0e56b2
Compare
Choose a tag to compare

What's Changed

✨ Improvements

🐛 Fixes

  • stats: private _continuous_distns functions should accept scalars by @jorenham in #694
  • special.logsumexp: add missing axis parameter defaults by @jorenham in #698

📝 Documentation

Other Changes

Full Changelog: v1.16.0.1...v1.16.0.2

v1.16.0.1

30 Jun 21:09
v1.16.0.1
8f2ef65
Compare
Choose a tag to compare

This is the second scipy-stubs release that supports SciPy 1.16. In these last 2 weeks of hard work, we've also made many improvements to the accuracy, correctness, and documentation of scipy-stubs.
If you encounter any regressions or other issues, please report them at https://github.com/scipy/scipy-stubs/issues.

This release requires Python 3.11-3.13 and NumPy 1.25.2 or greater.

What's Changed

👽️ SciPy Changes

  • scipy 1.16 changes for optimize.fmin_l_bfgs_b by @jorenham in #643

✨ Improvements

  • stats: Annotate the private functions and consts in _continuous_distns by @jorenham in #650
  • cluster.vq: improved dtype annotations by @jorenham in #651
  • interpolate: Generic Krogh and barycentric interpolator types by @jorenham in #667
  • optimize: Generic Bounds type by @jorenham in #675
  • sparse.linalg: Improved linear solver function annotations by @jorenham in #678
  • fft: improved *fft, *fft2 and *fftn annotations by @jorenham in #681
  • fft: improved [i]fftshift annotations by @jorenham in #682
  • fft: sync (private) signatures of _realtransforms and _realtransforms_backend by @jorenham in #684

🐛 Fixes

  • stats.qmc: Add missing seed constructor parameters by @jorenham in #647
  • optimize: accept tuple functions in fmin_l_bfgs_b by @jorenham in #649
  • cluster.vq: Add missing seed parameter to kmeans and kmeans2 by @jorenham in #652
  • interpolate: Add missing seed kwarg to the BarycentricInterpolator constructor by @jorenham in #654
  • linalg: Add missing seed kwarg to clarkson_woodruff_transform by @jorenham in #655
  • optimize: Add missing seed kwargs to the global optimize functions by @jorenham in #656
  • sparse: Add missing random_state kwarg to random_array and rand[om] by @jorenham in #657
  • sparse.linalg: Add missing random_state kwarg to svds by @jorenham in #658
  • spatial.distance: Add missing seed kwarg to directed_hausdorff by @jorenham in #659
  • spatial.transform: Add missing random_state kwarg to Rotation.random by @jorenham in #660
  • stats: Add missing random_state kwargs by @jorenham in #661
  • sparse: fix sparse array/matrix indexing by @jorenham in #664
  • signal: simplify get_window input type by @jorenham in #665
  • sparse: Transposition duality of CSR and CSC arrays by @jorenham in #669
  • sparse.linalg: Fix factorize return type annotations by @jorenham in #679
  • interpolate: consistent RBFInterpolator generic type parameter ordering by @jorenham in #685

⬆️ Dependencies

📝 Documentation

Other Changes

  • 🏷️ io: loadmat return dict with gradual value types by @jorenham in #676
  • 💬 update string literals for SciPy 1.16.0 by @jorenham in #683
  • 🔧 update release note config by @jorenham in #686
  • 🧑‍💻 update editorconfig and vscode settings by @jorenham in #687
  • 🧑‍💻 dprint formatter for markdown, json, toml and yaml by @jorenham in #688
  • ⬆️ Bump crate-ci/typos from 1.33.1 to 1.34.0 in the actions group by @dependabot in #689

Full Changelog: v1.16.0.0...v1.16.0.1

v1.16.0.0

18 Jun 03:49
v1.16.0.0
228894c
Compare
Choose a tag to compare

This is the first scipy-stubs release that supports SciPy 1.16. In these last 6 weeks of hard work, we've also made many improvements to the accuracy, correctness, and testing coverage of scipy-stubs.
If you encounter any regressions or other issues, please report them at https://github.com/scipy/scipy-stubs/issues.

This release requires Python 3.11-3.13 and NumPy 1.25.2 or greater.

⭐ Highlights

  • Support for SciPy 1.16 (currently 1.16.0rc2) (release notes)
  • Support for NumPy 2.3 (currently 2.3.0) (release notes)
  • scipy.linalg: Low-level BLAS and LAPACK function annotations
  • scipy.sparse: Many sparse array and matrix improvements, including preliminary shape-typing support
  • Improved type-testing coverage, which uncovered several bugs that have now been fixed

See below for the complete list of PR's that are included in this scipy-stubs release.

What's Changed

👽️ SciPy 1.16.0 Changes

  • scipy 1.16 changes for _lib by @jorenham in #525
  • scipy 1.16 changes for cluster.vq.whiten by @jorenham in #526
  • scipy 1.16 changes for interpolate.dfitpack by @jorenham in #527
  • scipy 1.16 change for interpolate.RectBivariateSpline by @jorenham in #528
  • scipy 1.16 change for interpolate.make_smoothing_spline by @jorenham in #529
  • scipy 1.16 addition for io.matlab by @jorenham in #530
  • scipy 1.16 changes for linalg.sqrtm by @jorenham in #531
  • scipy 1.16 new function ndimage.vectorized_filter by @jorenham in #537
  • scipy 1.16 batching support in scipy.linalg by @jorenham in #535
  • scipy 1.16 changes for optimize._differentiable_functions by @jorenham in #538
  • scipy 1.16 changes for optimize.least_squares by @jorenham in #539
  • scipy 1.16 changes for optimize._numdiff by @jorenham in #540
  • scipy 1.16 changes for optimize._trustregion_constr by @jorenham in #541
  • scipy 1.16 changes for optimize.nnls by @jorenham in #542
  • scipy 1.16 changes for optimize.slsqp by @jorenham in #544
  • scipy 1.16 additions for signal._short_time_fft by @jorenham in #546
  • scipy 1.16 new function signal.firwin_2d by @jorenham in #548
  • scipy 1.16 changes for signal.__all__ by @jorenham in #549
  • scipy 1.16 changes for signal.windows by @jorenham in #550
  • signal: dedupe the @deprecated public submodule function definitions by @jorenham in #551
  • scipy 1.16 deprecations for linalg.{logm, signm, sqrtm} by @jorenham in #553
  • scipy 1.16 new internal module _lib._sparse by @jorenham in #555
  • scipy 1.16 changes for sparse._base by @jorenham in #556
  • scipy 1.16 removals for sparse by @jorenham in #557
  • scipy 1.16 changes for sparse.csgraph._shortest_path by @jorenham in #558
  • scipy 1.16 changes for sparse._sputils by @jorenham in #559
  • scipy 1.16 expired deprecations for sparse._dok by @jorenham in #560
  • scipy 1.16 additions for spatial.transform._rotation by @jorenham in #561
  • scipy 1.16 new class spatial.transform.RigidTransform by @jorenham in #562
  • scipy 1.16 changes for special._support_alternative_backends by @jorenham in #563
  • scipy 1.16 new function stats.quantile by @jorenham in #564
  • scipy 1.16 changes for stats.make_distribution by @jorenham in #565
  • scipy 1.16 new class stats._distribution_infrastructure by @jorenham in #566
  • scipy 1.16 new class stats.Binomial by @jorenham in #567
  • scipy 1.16 removal of stats._mvn by @jorenham in #569
  • scipy 1.16 changes for stats.tukey_hsd by @jorenham in #570
  • scipy 1.16 changes for stats.f_oneway by @jorenham in #573
  • scipy 1.16 removal of stats.trapz by @jorenham in #574
  • scipy 1.16 changes for stats.multivariate_normal.[log]cdf by @jorenham in #575
  • scipy 1.16 changes for stats.gaussian_kde.integrate_box by @jorenham in #576
  • scipy 1.16 changes for stats.boxcox_llf by @jorenham in #577
  • scipy 1.16 changes for stats.{siegel,theil}slopes by @jorenham in #580
  • scipy 1.16 changes for stats.gstd by @jorenham in #581
  • scipy 1.16 changes for stats.power_divergence and stats.chisquare by @jorenham in #582
  • scipy 1.16 expired deprecation for stats.linregress by @jorenham in #583
  • scipy 1.16 changes for stats.linregress by @jorenham in #584
  • scipy 1.16 changes for stats.pointbiserialr by @jorenham in #585
  • scipy 1.16 changes for stats.{kendall,weighted}tau by @jorenham in #586
  • scipy 1.16 changes for version by @jorenham in #587

✨ Improvements

  • signal: generic ShortTimeFFT type-param and improved annotations by @jorenham in #547
  • linalg: improved _matfuncs return dtypes by @jorenham in #554
  • stats: improved hypothesis test function return type annotations by @jorenham in #571
  • linalg: low-level BLAS function annotations by @jorenham in #594
  • linalg: low-level LAPACK function annotations by @jorenham in #595
  • optimize: stub _slsqplib cpython extension module by @jorenham in #596
  • linalg: stub _decomp_interpolative cpython extension module by @jorenham in #597
  • stats: stub the _rcont subpackage by @jorenham in #598
  • sparse: improved annotations and code cleanup by @jorenham in #602
  • sparse: type testing & sparse matrix and array improvements by @jorenham in #605
  • constants: type-tests & improved annotations by @jorenham in #610
  • sparse: constructor function type-tests by @jorenham in #619
  • sparse: improved integer matrix/array method annotations by @jorenham in #624
  • sparse: fix and improve get_index_type return type by @jorenham in #625
  • sparse: simplified gradual load_npz return type by @jorenham in #626
  • preliminary support for Python 3.14 by @jorenham in #631
  • sparse: Improved shape-typing support for CSR and DOK arrays by @jorenham in #634
  • fft: improved [i]fht() annotations by @jorenham in #640
  • fft: improved discrete sine- and cosine transform return types by @jorenham in #641

🐛 Fixes

Read more

v1.15.3.0 (scipy 1.15.3)

08 May 16:58
v1.15.3.0
8afe864
Compare
Choose a tag to compare

⭐ Highlights

What's Changed

🐛 Fixes

⬆️ Dependencies

Other Changes

New Contributors

Full Changelog: v1.15.2.2...v1.15.3.0

v1.15.2.2 (scipy 1.15.2)

07 Apr 20:58
v1.15.2.2
5630a80
Compare
Choose a tag to compare

What's Changed

✨ Improvements

  • ndimage: improved filter and measurement function annotations by @jorenham in #499
  • optimize: narrowed OptimizeResult.{fun,x} attrs for minimize[_scalar] by @jorenham in #504

🐛 Fixes

  • adjust pyright config for optype.numpy compatibility by @jorenham in #491
  • interpolate: accept ndarray for points in RegularGridInterpolator by @jorenham in #501
  • optimize: accept a scalar for x0 in minimize by @jorenham in #502
  • optimize: accept a scalar for x0 in fmin* by @jorenham in #503

📝 Documentation

⬆️ Dependencies

Other Changes

Full Changelog: v1.15.2.1...v1.15.2.2

v1.15.2.1 (scipy 1.15.2)

12 Mar 13:32
v1.15.2.1
4e581c8
Compare
Choose a tag to compare

What's Changed

✨ Improvements

  • interpolate: improved support for complex splines by @jorenham in #477

🐛 Fixes

📝 Documentation

Dependencies

Other Changes

New Contributors

Full Changelog: v1.15.2.0...v1.15.2.1

v1.15.2.0

17 Feb 05:04
v1.15.2.0
76b2d8a
Compare
Choose a tag to compare

⭐ Highlights

  • The repo has been transferred from jorenham/scipy-stubs to scipy/scipy-stubs by @rgommers
  • Support for SciPy 1.15.2 and NumPy 2.2.3

What's Changed

✨ Improvements

  • special: improved dtype handling in the "basic" functions by @jorenham in #419
  • signal: generic lti, and dlti types by @jorenham in #425
  • optimize: improved linprog and milp annotations by @jorenham in #427
  • optimize: method-specific overloads and options for minimize_scalar by @jorenham in #428
  • optimize: Generic InverseJacobian and related types by @jorenham in #429
  • signal: improvements related to czt and zoom_fft by @jorenham in #430
  • sparse: generic sparray by @jorenham in #435
  • stats.zmap: accept complex input and basic shape-typing by @jorenham in #457

🐛 Fixes

  • stats: fix rv_discrete sample constructor by @jorenham in #418
  • signal: add plain number option for find_peaks argument prominence by @drewsilcock in #448
  • stats: make optimizer argument optional in rv_continuous.fit() by @drewsilcock in #451

📝 Documentation

⬆️ Dependencies

Other Changes

New Contributors

Full Changelog: v1.15.1.0...v1.15.2.0

v1.15.1.0 (scipy 1.15.1)

11 Jan 01:40
v1.15.1.0
9c6a2d7
Compare
Choose a tag to compare

This is the first scipy-stubs release that supports SciPy 1.15.1.

What's Changed

Improvements

Dependencies

Other Changes

  • 🎨 fix and run the FixTrailingComma codemod by @jorenham in #397

Full Changelog: v1.15.0.0...v1.15.1.0

v1.15.0.0 (scipy 1.15.0)

01 Jan 18:57
v1.15.0.0
d715ec0
Compare
Choose a tag to compare

This is the first scipy-stubs release that supports SciPy 1.15.0.

What's Changed

SciPy 1.15.0 compatability

  • ⬆️ increase the minimum scipy version to 1.15.0rc1 by @jorenham in #327
  • 🚧 temporarily ignore all stubtest errors by @jorenham in #326
  • ⚰️ misc: remove all code by @jorenham in #328
  • differentiate: preliminary (yet complete) stubs by @jorenham in #329
  • 🏷️ _typing: SPEC-7 compliant (private) ToRNG type alias (previously Seed) by @jorenham in #333
  • 👽️ fft[pack]: 1.15.0 support by @jorenham in #336
  • 👽️ integrate: 1.15.0 support by @jorenham in #337
  • 👽️ interpolate: 1.15.0 support by @jorenham in #338
  • 👽️ constants: 1.15.0 support by @jorenham in #330
  • 👽️ _lib: 1.15.0 support by @jorenham in #331
  • 👽️ cluster: 1.15.0 support by @jorenham in #334
  • 👽️ io: 1.15.0 support by @jorenham in #341
  • 👽️ linalg.interpolative: 1.15.0 support by @jorenham in #343
  • 👽️ linalg: 1.15.0 support by @jorenham in #344
  • 👽️ version: 1.15.0 remove commit_count by @jorenham in #345
  • 👽️ ndimage: 1.15.0 support by @jorenham in #346
  • 👽️ optimize: SPEC 7 & scipy 1.15.0 support by @jorenham in #347
  • 👽️ sparse: 1.15.0 support by @jorenham in #349
  • 👽️ special: 1.15.0 support by @jorenham in #351
  • 👽️ signal: 1.15.0 support by @jorenham in #348
  • 👽️ spatial: 1.15.0 support and many improvements by @jorenham in #350
  • 👽️ stats: 1.15.0 support and several improvements by @jorenham in #353
  • 👽️ sparse: accept axes: tuple[int[:], int[:]] in coo_array.tensordot by @jorenham in #357
  • 👽️ stats: 1.15.0 new distribution infrastructure by @jorenham in #360
  • 💬 interpolate: fix scipy version in interpnd deprecation warning messages by @jorenham in #366
  • 💬 special: mention the deprecation version in lpn and [c]lpmn by @jorenham in #367
  • 🗑️ interpolate: deprecate the dfitpack functions, fix & improve the sp* functions by @jorenham in #372
  • 📌 pin scipy<1.16 by @jorenham in #371
  • 👽️ scipy==1.15.0rc2 by @jorenham in #376

Improvements

Fixes

  • 🐛 sparse: add the missing sparse array/matrix dunder methods by @jorenham in #391

Documentation

Dependencies

Other Changes

Full Changelog: v1.14.1.6...v1.15.0.0

v1.14.1.6

15 Dec 23:07
v1.14.1.6
5714501
Compare
Choose a tag to compare

Highlights

  • scipy.interpolate: The public API is now 100% annotated (by humans)
  • scipy.sparse: The public API is now 100% annotated (by humans)
    • the sparse array- and matrix- types optionally accept a generic type parameter for their scalar type, e.g. coo_array[np.float64].
    • {coo, csr, dok}_array additionally accept a 2nd optional type parameter for their 1-d (tuple[int]) or 2-d (tuple[int, int]) shape-type.
  • fixed some typing issues on older numpy versions

What's Changed

Improvements

  • 🎨 interpolate: remove duplicated function and classes by @jorenham in #267
  • interpolate: stub _dfitpack by @jorenham in #270
  • spatial: improve _qhull by @jorenham in #271
  • interpolate: complete and improve interpnd by @jorenham in #272
  • interpolate: complete _bsplines and _ndbspline by @jorenham in #273
  • interpolate: complete RBFInterpolator and Rbf by @jorenham in #274
  • interpolate: complete _fitpack_impl (1/2) by @jorenham in #275
  • interpolate: complete _fitpack_impl (2/2) by @jorenham in #276
  • interpolate: complete _fitpack2 by @jorenham in #277
  • interpolate: complete _polyint by @jorenham in #279
  • signal: complete frequency response functions in _filter_design by @jorenham in #287
  • 🎨 sparse: code cleanup by @jorenham in #294
  • sparse.linalg: complete the LinearOperators in _interface by @jorenham in #295
  • 🎨 sparse explicit imports in __init__ by @jorenham in #296
  • sparse.linalg: complete the matrix operation functions by @jorenham in #298
  • sparse.linalg: complete the matrix norm functions by @jorenham in #300
  • sparse.linalg: complete LaplacianNd & accept in dtypes in LinearOperator by @jorenham in #301
  • sparse.linalg: complete _dsolve by @jorenham in #302
  • sparse.linalg: complete _eigen.arpack by @jorenham in #303
  • sparse.linalg: complete lobpcg by @jorenham in #305
  • sparse.linalg: complete svds by @jorenham in #306
  • sparse: complete the sparse arrays and matrices by @jorenham in #307
  • sparse: complete eye[_array] by @jorenham in #309
  • sparse: complete identity by @jorenham in #310
  • sparse: complete kron[sum] by @jorenham in #311
  • sparse: complete {h,v}stack by @jorenham in #313
  • sparse: complete [sp]diags[_array] by @jorenham in #314
  • sparse: complete {load,save}_npz by @jorenham in #315
  • sparse: complete _sputils.* (private) by @jorenham in #316
  • sparse: complete _spfuncs.* (private) by @jorenham in #317
  • sparse: complete find and tri{l,u} by @jorenham in #318
  • sparse: complete rand[om[_array]] by @jorenham in #319
  • sparse: complete bmat and block_{array,diag} by @jorenham in #320
  • sparse: adopt the new generic sparse arrays in linalg and csgraph by @jorenham in #321
  • 🎨 sparse: various linalg.LinearOperator tweaks and improvements by @jorenham in #322
  • sparse: complete linalg.ls{m,q}r by @jorenham in #323
  • sparse: complete linalg._isolve.utils.* (private) by @jorenham in #324
  • sparse: complete the remaining sparse.linalg functions by @jorenham in #325

Fixes

Documentation

  • 🌕 interpolate: mark as 100% annotated by @jorenham in #280
  • 📝 correct the documented lowest supported numpy version by @jorenham in #281
  • 📝 installation instructions for humans by @jorenham in #282
  • 🎤 add podcast to README.md by @jorenham in #299
  • 📝 update the coverage progress for scipy.sparse by @jorenham in #304
  • 📝 mention gitmoji in CONTRIBUTING.md by @jorenham in #308

Dependencies

Other Changes

  • 🧑‍💻 uv-compatible mypy vscode config by @jorenham in #256
  • 💡 add a comment to prevent breaking the #installation permalink by @jorenham in #266
  • 🔧 fix caching issue in poe {mypy,stubtest,typetest} by @jorenham in #269
  • 🔧 stricter basedpyright config by @jorenham in #283
  • 👷 include .mypyignore in sdist build by @jorenham in #284
  • ➖ remove broken mdformat-pyproject by @miloth in #262
  • 💚 towards fixing the typetest-oldest-supported-numpy CI job by @jorenham in #289
  • 👷 fix and simplify the CI workflow by @jorenham in #290
  • Dynamic testing matrix for combinations of python and numpy versions. by @wolph in #286

New Contributors

AI generated Podcast

SciPy.Type.Hints.mp4

Full Changelog: v1.14.1.5...v1.14.1.6