Releases: scipy/scipy-stubs
v1.16.1.1
This release targets SciPy 1.16.1 and requires Python 3.11-3.14, NumPy 1.25-2.3, and optype 0.13.4.
What's Changed
✨ Improvements
sparse
: improved block-related sparse construction functions by @JulVandenBroeck in #775sparse
: improve thelil_matrix
andlil_array
constructors by @jorenham in #818stats
: improvemode
by @jorenham in #812stats
: improvepearsonr
by @jorenham in #814stats
: improvesem
by @jorenham in #815stats
: improvezscore
andgzscore
by @jorenham in #816
🐛 Fixes
sparse
: fix thelil_matrix
andlil_array
constructors by @jorenham in #818stats
: fixmode
return type by @jorenham in #809
⬆️ Dependencies
- bump
ruff
to0.12.9
andbasedpyright
to1.31.2
by @jorenham in #813 - upgrade
optype
to0.13.4
by @jorenham in #821 - pin
uv_build
by @jorenham in #821 - exclude pyright 1.1.404 by @jorenham in #823
Other Changes
Full Changelog: v1.16.1.0...v1.16.1.1
v1.16.1.0
This is the first scipy-stubs
release that officially supports SciPy 1.16.1. In these last 4 weeks of hard work, we've made many improvements to the accuracy and correctness of many annotations, and improved compatibility with older NumPy versions.
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.14, NumPy 1.25.2 or greater, and optype 0.13.1 or greater.
What's Changed
👽️ SciPy 1.16.1 Changes
✨ Improvements
- 🏷️
linalg
: stub more of the internal scipy machinery by @jorenham in #710 - ✨
linalg
: support sparse arrays inclarkson_woodruff_transform
by @jorenham in #711 - ✨ stub
scipy._cyutility
by @jorenham in #712 - 🏷️
_lib
: stub_ccallback_c
and_array_api[_compat_vendor]
by @jorenham in #713 - 🏷️
cluster
: stub internal cython submodules by @jorenham in #714 - 🏷️
integrate
: stubintegrate._rules.*
(private api) by @jorenham in #715 - 🏷️
integrate
: stub the remaining private C-extension modules by @jorenham in #716 - 🏷️
interpolate
: stub the remaining private C- and cython modules by @jorenham in #717 - 🏷️
io.matlab
: stub private cython modules by @jorenham in #718 - 🏷️
sparse
: added stubs for all formats inkron
andkronsum
by @JulVandenBroeck in #719 - 🏷️
ndimage
: stub the remaining private modules by @jorenham in #720 - 🏷️
optimize
: stub the remaining private modules by @jorenham in #722 - 🏷️
signal
: stub the remaining private modules by @jorenham in #723 - 🏷️
sparse
: stub the remaining private modules by @jorenham in #724 - 🏷️
spatial
: stub the remaining private modules by @jorenham in #725 - 🏷️
special
: stub the remaining private modules by @jorenham in #726 - 🏷️
stats
: stub the remaining private modules by @jorenham in #727 - ✨
stats
: improved[differential_]entropy
annotations by @jorenham in #738 - ✨
stats
: improvedCovariance
generic type parameter inference by @jorenham in #739 - ✨
ndimage
: improvedfourier_*
annotations by @jorenham in #740 - ✨
linalg
: improved basicsolve*
annotations by @jorenham in #741 - ✨
linalg
: improvedinv
annotations by @jorenham in #743 - ✨
linalg
: improveddet
annotations by @jorenham in #744 - 🧑💻 vscode tasks for basedpyright, mypy, and stubtest by @jorenham in #754
- ✨
linalg
: improvedeigh
return type inference for float64 by @jorenham in #755 - 🏷️
sparse
: overhauled stubs fordiags_array
,eye_array
, and their matrix equivalents by @JulVandenBroeck in #733 - ✨
integrate
: improve theodeint
signature by @jorenham in #763 - ✨
integrate
: improvedsolve_ivp
annotations by @jorenham in #765 - ✨
signal
: improved convolution and correlation functions by @jorenham in #767 - ✨
signal
: improvedfilter
function annotations by @jorenham in #768 - Add
hstack
andvstack
overloads for different sparse formats by @JulVandenBroeck in #774
🐛 Fixes
- 🐛
sparse.linalg
: allow passing arrays toexpm_multiply
by @jorenham in #708 - 🐛
sparse.linalg
: fix severalLinearOperator
issues by @jorenham in #709 - 🏷️
sparse
: improved init stubs of sparse arrays with shape as positional argument. by @JulVandenBroeck in #704 - 🐛
sparse
: csc array/matrix constructor fixes by @jorenham in #753 - 🩹 fix missing type arguments on
numpy<2.3
by @jorenham in #779 - 🚨
fftpack
: fix stubtest error onnumpy<2
by @jorenham in #786 - ✅ fix failing type-tests on
numpy==2.2.*
by @jorenham in #787 - ✅ fix failing type-tests on
numpy==2.1.*
by @jorenham in #788 - ✅ fix failing type-tests on
numpy<2.1
by @jorenham in #789 - 💚 fix CI numpy testing matrix by @jorenham in #778
- 🐛
interpolate
: Fix incorrect return type formake_lsq_spline
by @elael in #776 - 🩹
optimize
: fix compatibility issues withABCPolyBase
onnumpy==2.1
by @jorenham in #780 - 🩹 fix compatibility issues with
np.[c]longdouble
onnumpy<2.2
by @jorenham in #781 - 🗑️
special.comb
: remove expired@deprecated
non-integerexact=True
overloads by @jorenham in #793
📝 Documentation
- add a "who's using scipy-stubs" section to the readme by @jorenham in #732
- add
scanpy
as dependent project by @jorenham in #747 CONTRIBUTING.md
fixes by @jorenham in #760- add xarray, radioactivedecay, neurogym, and foamlib to the list of dependents by @jorenham in #772
⬆️ Dependencies
- bump
ruff
to0.12.2
by @jorenham in #707 - basedpyright 1.30.0 (pyright 1.1.403) by @jorenham in #734
- bump
mypy
to1.17.0
by @jorenham in #746 - upgrade
optype
to0.12.0
by @jorenham in #750 - bump
basedpyright
to1.31.0
by @jorenham in #751 - bump
ruff
to0.12.3
by @jorenham in #752 - bump
ruff
to0.12.4
by @jorenham in #757 - bump
setup-uv
tov6.4.0
by @jorenham in #758 - Bump astral-sh/setup-uv from 6.4.0 to 6.4.1 in the actions group by @dependabot[bot] in #759
- bump
optype
to0.12.2
by @jorenham in #761 - Bump astral-sh/setup-uv from 6.4.1 to 6.4.3 in the actions group by @dependabot[bot] in #770
- numpy 2.3.2 and ruff 0.12.5 by @jorenham in #771
- numpy 2.3.2 and ruff 0.12.5 by @jorenham in #771
- bump
ruff
to0.12.7
by @jorenham in #790 - bump
mypy
to1.17.1
by @jorenham in #794
Other Changes
- 🔖 prepare for further development by @jorenham in #701
- 🔨 dev script for listing all (private) unstubbed modules by @jorenham in #706
- 🎨 use 88 as max line length for
scipts/*.py
by @jorenham in #721 - 📌 pin CI action version tags by @jorenham in #728
- ♻️ always use
optype.numpy.compat
for abstract scalar types by @jorenham in #730 - ♻️ reduce reliance on "fake"
*._typing
modules by @jorenham in #731 - ♻️ explicit
onp.AnyFloat64DType | None
by @jorenham in #735 - 🎨 workaround for path-dependent pyright bug by shuffling disjoint overloads by @jorenham in #745
- 🎨
linalg
: simplified_decomp_svd
type aliases by @jorenham in #749 - 🤖 correct TypeVarTuple naming in copilot instructions by @jorenham in #764
- 🐴 work around false positive
overload-overlap
mypy errors onnumpy>=2.2
by @jorenham in #782 - 🤡 work around false positive
reportOverlappingOverload
pyright errors onnumpy<2.1
by @jorenham in #783 - 🐴
special
: work around false positiveoverload-overlap
mypy errors onnumpy<2.1
by @jorenham in #785 - 📄 explicit
license-files
by @jorenham in #795 - 🧱
uv_build
by @jorenham in #796
🎉 New Contributors
- @JulVandenBroeck made their first contribution in https://githu...
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