Releases: scipy/scipy-stubs
v1.16.0.2
What's Changed
✨ Improvements
special
: improvedlogsumexp
and[log_]softmax
by @jorenham in #699linalg
: improvedsvd
annotations by @jorenham in #700
🐛 Fixes
stats
: private_continuous_distns
functions should accept scalars by @jorenham in #694special.logsumexp
: add missingaxis
parameter defaults by @jorenham in #698
📝 Documentation
Other Changes
- 🔖 prepare for further development by @jorenham in #692
- 📝 color-theme-dependent examples by @jorenham in #693
- 🔧 fix pyright execution environment config by @jorenham in #696
Full Changelog: v1.16.0.1...v1.16.0.2
v1.16.0.1
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
✨ Improvements
stats
: Annotate the private functions and consts in_continuous_distns
by @jorenham in #650cluster.vq
: improved dtype annotations by @jorenham in #651interpolate
: Generic Krogh and barycentric interpolator types by @jorenham in #667optimize
: GenericBounds
type by @jorenham in #675sparse.linalg
: Improved linear solver function annotations by @jorenham in #678fft
: improved*fft
,*fft2
and*fftn
annotations by @jorenham in #681fft
: improved[i]fftshift
annotations by @jorenham in #682fft
: sync (private) signatures of_realtransforms
and_realtransforms_backend
by @jorenham in #684
🐛 Fixes
stats.qmc
: Add missingseed
constructor parameters by @jorenham in #647optimize
: accept tuple functions infmin_l_bfgs_b
by @jorenham in #649cluster.vq
: Add missingseed
parameter tokmeans
andkmeans2
by @jorenham in #652interpolate
: Add missingseed
kwarg to theBarycentricInterpolator
constructor by @jorenham in #654linalg
: Add missingseed
kwarg toclarkson_woodruff_transform
by @jorenham in #655optimize
: Add missingseed
kwargs to the global optimize functions by @jorenham in #656sparse
: Add missingrandom_state
kwarg torandom_array
andrand[om]
by @jorenham in #657sparse.linalg
: Add missingrandom_state
kwarg tosvds
by @jorenham in #658spatial.distance
: Add missingseed
kwarg todirected_hausdorff
by @jorenham in #659spatial.transform
: Add missingrandom_state
kwarg toRotation.random
by @jorenham in #660stats
: Add missingrandom_state
kwargs by @jorenham in #661sparse
: fix sparse array/matrix indexing by @jorenham in #664signal
: simplifyget_window
input type by @jorenham in #665sparse
: Transposition duality of CSR and CSC arrays by @jorenham in #669sparse.linalg
: Fixfactorize
return type annotations by @jorenham in #679interpolate
: consistentRBFInterpolator
generic type parameter ordering by @jorenham in #685
⬆️ Dependencies
- require
scipy>=1.16.0<1.17
by @jorenham in #642 - bump
ruff
to0.12.1
by @jorenham in #680 - bump
basedpyright
to1.29.5
by @jorenham in #691
📝 Documentation
- generic type reference docs by @jorenham in #673
- support versions of generic types by @jorenham in #690
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
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 annotationsscipy.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
andstats.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
: genericShortTimeFFT
type-param and improved annotations by @jorenham in #547linalg
: improved_matfuncs
return dtypes by @jorenham in #554stats
: improved hypothesis test function return type annotations by @jorenham in #571linalg
: low-level BLAS function annotations by @jorenham in #594linalg
: low-level LAPACK function annotations by @jorenham in #595optimize
: stub_slsqplib
cpython extension module by @jorenham in #596linalg
: stub_decomp_interpolative
cpython extension module by @jorenham in #597stats
: stub the_rcont
subpackage by @jorenham in #598sparse
: improved annotations and code cleanup by @jorenham in #602sparse
: type testing & sparse matrix and array improvements by @jorenham in #605constants
: type-tests & improved annotations by @jorenham in #610sparse
: constructor function type-tests by @jorenham in #619sparse
: improved integer matrix/array method annotations by @jorenham in #624sparse
: fix and improveget_index_type
return type by @jorenham in #625sparse
: simplified gradualload_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 #634fft
: improved[i]fht()
annotations by @jorenham in #640fft
: improved discrete sine- and cosine transform return types by @jorenham in #641
🐛 Fixes
signal
: accept numbers as args towidth
andplateau_size
forfind_peaks()
by @jorenham in #519- fix
numpy<2.2
compatability withnp.bool_
by @jorenham in #579 - prefer gradual shape-type defaults for generics by @jorenham in #601
sparse
: covariant sparse matrix/array types by @jorenham in #623sparse
: fix and improveget_index_type
return type by @jorenham in #625sparse
: distinguish between different values for argumentwhich
ineigs
andeigsh
by @lcwllmr in #633optimize
: fix false rejection of identity functions inminimize
by @jorenham in https://github.com/scipy/scipy-stubs/p...
v1.15.3.0 (scipy 1.15.3)
⭐ Highlights
- Support for SciPy 1.15.3 and NumPy 2.2.5
What's Changed
🐛 Fixes
⬆️ Dependencies
- upgrade development dependencies by @jorenham in #508
- bump
astral-sh/setup-uv
tov6
by @jorenham in #509 - update the dev dependencies by @jorenham in #514
- upgrade
scipy
to1.15.3
by @jorenham in #516
Other Changes
- 🔖 prepare for further development by @jorenham in #507
- Remove License Trove Classifier from
pyproject.toml
by @it176131 in #513 - 🛂 explicit CI permissions by @jorenham in #515
New Contributors
Full Changelog: v1.15.2.2...v1.15.3.0
v1.15.2.2 (scipy 1.15.2)
What's Changed
✨ Improvements
ndimage
: improved filter and measurement function annotations by @jorenham in #499optimize
: narrowedOptimizeResult.{fun,x}
attrs forminimize[_scalar]
by @jorenham in #504
🐛 Fixes
- adjust pyright config for
optype.numpy
compatibility by @jorenham in #491 interpolate
: acceptndarray
forpoints
inRegularGridInterpolator
by @jorenham in #501optimize
: accept a scalar forx0
inminimize
by @jorenham in #502optimize
: accept a scalar forx0
infmin*
by @jorenham in #503
📝 Documentation
⬆️ Dependencies
- upgrade
optype
to0.9.2
by @jorenham in #481 - bump
ruff
to0.11.0
by @jorenham in #484 - bump
numpy
to2.2.4
by @jorenham in #487 - update development dependencies by @jorenham in #489
- bump
optype
to0.9.3
by @jorenham in #490 - bump
ruff
to0.11.4
by @jorenham in #506
Other Changes
- 🔖 prepare for further development by @jorenham in #480
- 👷 ensure
pyright
compatibility by @jorenham in #482 - 🔧 adjust
basedmypy
config formypy
compat by @jorenham in #483 - 🔧 fix vscode settings syntax by @jorenham in #485
- 🔧 remove
files
from[tool.mypy]
by @jorenham in #486 - 💚 fix mypy_primer failure and mypy/basedmypy compat by @jorenham in #500
Full Changelog: v1.15.2.1...v1.15.2.2
v1.15.2.1 (scipy 1.15.2)
What's Changed
✨ Improvements
🐛 Fixes
optimize
: allow callingminimize_scalar
without abracket
by @jorenham in #467transform
: accept proper Euler angles inRotation.as_euler
by @KiSchnelle in #470interpolate
: accept scalar input in__call__
by @jorenham and @ev-br in #476 and #478
📝 Documentation
Dependencies
- ⬆️ bump
ruff
to0.9.7
by @jorenham in #460 - ⬆️
basedpyright 1.28.1
andruff 0.9.9
by @jorenham in #466
Other Changes
- 🔖 prepare for further development by @jorenham in #458
- 💄
add-trailing-comma
by @jorenham in #461 - 🔥 remove the codemods by @jorenham in #462
- 🔧 fix the
add-trailing-comma
hook to also work on.pyi
by @jorenham in #463 - 🔥 remove pre-commit by @jorenham in #469
New Contributors
- @KiSchnelle made their first contribution in #470
- @ev-br made their first contribution in #478
Full Changelog: v1.15.2.0...v1.15.2.1
v1.15.2.0
⭐ Highlights
- The repo has been transferred from
jorenham/scipy-stubs
toscipy/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 #419signal
: genericlti
, anddlti
types by @jorenham in #425optimize
: improvedlinprog
andmilp
annotations by @jorenham in #427optimize
: method-specific overloads and options forminimize_scalar
by @jorenham in #428optimize
: GenericInverseJacobian
and related types by @jorenham in #429signal
: improvements related toczt
andzoom_fft
by @jorenham in #430sparse
: genericsparray
by @jorenham in #435stats.zmap
: accept complex input and basic shape-typing by @jorenham in #457
🐛 Fixes
stats
: fixrv_discrete
sample constructor by @jorenham in #418signal
: add plain number option forfind_peaks
argument prominence by @drewsilcock in #448stats
: makeoptimizer
argument optional inrv_continuous.fit()
by @drewsilcock in #451
📝 Documentation
- Use SciPy's Code of Conduct by @jorenham in #439
- Streamlined contributing guide by @jorenham in #445
⬆️ Dependencies
- bump
sp-repo-review
to2025.1.22
by @jorenham in #426 - bump
basedpyright
to1.27.1
,ruff
to0.9.6
by @jorenham in #454 - Optype 0.9.1 by @jorenham in #449
- NumPy 2.2.3 by @jorenham in #455
- SciPy 1.15.2 by @jorenham in #456
Other Changes
- 🔖 prepare for further development by @jorenham in #415
- 🎨 optype 0.9 simplifications by @jorenham in #424
- 🔨 more
tox
, lesspoe
by @jorenham in #431 - ⬆️ bump
ruff
to0.9.3
by @jorenham in #432 - 🎨
sparse
: preferoptype.numpy
overscipy._typing
by @jorenham in #434 - 💸 remove the sponsor button by @jorenham in #437
- 🔧 scipy.org as homepage and add scipy-dev as maintainer by @jorenham in #440
- 🔧
.toml
auto-format config for vscode users by @jorenham in #444 - 🚚 change
jorenham/scipy-stubs
refs toscipy/scipy-stubs
by @jorenham in #446 - 🔨 use
uv
as source of python versions by @jorenham in #452
New Contributors
- @drewsilcock made their first contribution in #448
Full Changelog: v1.15.1.0...v1.15.2.0
v1.15.1.0 (scipy 1.15.1)
This is the first scipy-stubs
release that supports SciPy 1.15.1.
What's Changed
Improvements
- 🎨 remove outdated
# TODO
's by @jorenham in #408 - ✨
spatial
: generic[c]KDTree
and other improvements by @jorenham in #413
Dependencies
- ⬆️ bump
ruff
to0.8.5
by @jorenham in #396 - ⬆️ bump
scipy
to1.15.0
(final) by @jorenham in #409 - ⬆️ bump dev deps to latest by @jorenham in #410
- ⬆️ bump
ruff
to0.9.0
by @jorenham in #412 - 📌 SciPy 1.15.1 by @jorenham in #414
Other Changes
Full Changelog: v1.15.0.0...v1.15.1.0
v1.15.0.0 (scipy 1.15.0)
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 to1.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 (previouslySeed
) 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 removecommit_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
: acceptaxes: tuple[int[:], int[:]]
incoo_array.tensordot
by @jorenham in #357 - 👽️
stats
: 1.15.0 new distribution infrastructure by @jorenham in #360 - 💬
interpolate
: fix scipy version ininterpnd
deprecation warning messages by @jorenham in #366 - 💬
special
: mention the deprecation version inlpn
and[c]lpmn
by @jorenham in #367 - 🗑️
interpolate
: deprecate thedfitpack
functions, fix & improve thesp*
functions by @jorenham in #372 - 📌 pin
scipy<1.16
by @jorenham in #371 - 👽️
scipy==1.15.0rc2
by @jorenham in #376
Improvements
- ✨ more precise
__config__
and__init__
annotations by @jorenham in #362 - ✨
_lib
: improved annotations by @jorenham in #364 - ✨
special
: several improved ufuncs by @jorenham in #374 - ✨
special
: ufunc improvements by @jorenham in #375 - ✨
signal
: complete_filter_design
, fix and improve_czt
by @jorenham in #378 - ✨
signal
: complete_signaltools
by @jorenham in #379 - ✨
signal
: complete_fir_filter_design.*
enmax_len_seq
by @jorenham in #384 - ✨
signal
: complete_ltisys.*
by @jorenham in #385 - 🎨
optype 0.8
simplifications by @jorenham in #382 - 🎨
stats
: simplify_distn_infrastructure
withoptype 0.8
by @jorenham in #387 - 🎨
_typing
: DRYFalsy
andTruthy
type aliases by @jorenham in #390
Fixes
Documentation
- 📝 several
README.md
improvements by @jorenham in #365 - 📝 better describe the supported numpy versions by @jorenham in #368
Dependencies
- 📌 upgrade
optype
to0.8.0
by @jorenham in #380 - ⬆️ update pre-commit hooks by @pre-commit-ci in #339
- ⬆️ bump
basedpyright
to1.23.1
by @jorenham in #356 - ⬆️ bump
ruff
to0.8.4
and disallowmdformat==0.7.20
by @jorenham in #358 - ⬆️ bump
mdformat
to0.7.21
by @jorenham in #359 - ⬆️ bump
basedmypy
to2.9.0
by @jorenham in #393 - Bump astral-sh/setup-uv from 4 to 5 in the actions group by @dependabot in #361
- Bump DavidAnson/markdownlint-cli2-action from 18 to 19 in the actions group by @dependabot in #386
Other Changes
- 🧑💻 remove mypy from pre-commit (too slow) by @jorenham in #355
- 👷 increase the timeout of the CI
typetest
step by @jorenham in #342 - 👷 PyPI trusted publishing workflow by @jorenham in #383
- 👷 exclude unsupported test matrix version combinations by @jorenham in #388
- 🔧 configure pre-commit ci to use gitmoji style by @jorenham in #340
- 🔧 de-duplicate the
scipy
version requirements by @jorenham in #389 - 🔧 regex'd
.mypyignore
by @jorenham in #335 - 🔧
.mypyignore
cleanup by @jorenham in #392
Full Changelog: v1.14.1.6...v1.15.0.0
v1.14.1.6
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.
- the sparse array- and matrix- types optionally accept a generic type parameter for their scalar type, e.g.
- 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 improveinterpnd
by @jorenham in #272 - ✨
interpolate
: complete_bsplines
and_ndbspline
by @jorenham in #273 - ✨
interpolate
: completeRBFInterpolator
andRbf
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 theLinearOperator
s 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
: completeLaplacianNd
& accept in dtypes inLinearOperator
by @jorenham in #301 - ✨
sparse.linalg
: complete_dsolve
by @jorenham in #302 - ✨
sparse.linalg
: complete_eigen.arpack
by @jorenham in #303 - ✨
sparse.linalg
: completelobpcg
by @jorenham in #305 - ✨
sparse.linalg
: completesvds
by @jorenham in #306 - ✨
sparse
: complete the sparse arrays and matrices by @jorenham in #307 - ✨
sparse
: completeeye[_array]
by @jorenham in #309 - ✨
sparse
: completeidentity
by @jorenham in #310 - ✨
sparse
: completekron[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
: completefind
andtri{l,u}
by @jorenham in #318 - ✨
sparse
: completerand[om[_array]]
by @jorenham in #319 - ✨
sparse
: completebmat
andblock_{array,diag}
by @jorenham in #320 - ✨
sparse
: adopt the new generic sparse arrays inlinalg
andcsgraph
by @jorenham in #321 - 🎨
sparse
: variouslinalg.LinearOperator
tweaks and improvements by @jorenham in #322 - ✨
sparse
: completelinalg.ls{m,q}r
by @jorenham in #323 - ✨
sparse
: completelinalg._isolve.utils.*
(private) by @jorenham in #324 - ✨
sparse
: complete the remainingsparse.linalg
functions by @jorenham in #325
Fixes
- ✨
interpolate
: complete_rgi
by @jorenham in #278 - 🐛 fix typing errors on
numpy<1.24
by @jorenham in #292 - ⬆️ bump
basedmypy
to2.8.1
by @jorenham in #293 - 👽️ work around several
mypy
bugs withnumpy>=2.2.0
by @jorenham in #288
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
- ⬆️ bump
basedpyright
to1.22.1
andbasedmypy
to2.8.0
by @jorenham in #255 - dynamic minimum requirements by @miloth in #259
- ⬆️ bump
ruff
to0.8.2
by @jorenham in #265 - ⬆️ bump the dev deps by @jorenham in #312
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