diff --git a/.github/workflows/ci.yml b/.github/workflows/ci.yml index 00acacc9..54b636e5 100644 --- a/.github/workflows/ci.yml +++ b/.github/workflows/ci.yml @@ -52,7 +52,7 @@ jobs: # TODO: don't continue on error - name: basedmypy stubtest - run: poetry run stubtest --concise --mypy-config-file=pyproject.toml --allowlist=tests/stubtest/allowlist.txt scipy + run: poetry run stubtest --concise --ignore-positional-only --mypy-config-file=pyproject.toml --allowlist=tests/stubtest/allowlist.txt scipy continue-on-error: true # TODO diff --git a/README.md b/README.md index f6f42f68..4b5720f4 100644 --- a/README.md +++ b/README.md @@ -104,7 +104,6 @@ pyright), the "type completeness score" is **42.4%**. | `scipy.odr` | 1: skeleton | | `scipy.optimize` | 2: partial | | `scipy.optimize.cython_optimize` | 0: missing | -| `scipy.optimize.zeros` | 0: missing | | `scipy.signal` | 2: partial | | `scipy.signal.windows` | 1: skeleton | | `scipy.sparse` | 2: partial | diff --git a/scipy-stubs/constants/codata.pyi b/scipy-stubs/constants/codata.pyi deleted file mode 100644 index 3267c078..00000000 --- a/scipy-stubs/constants/codata.pyi +++ /dev/null @@ -1,2 +0,0 @@ -# This file is not meant for public use and will be removed in SciPy v2.0.0. -__all__ = () diff --git a/scipy-stubs/constants/constants.pyi b/scipy-stubs/constants/constants.pyi deleted file mode 100644 index 3267c078..00000000 --- a/scipy-stubs/constants/constants.pyi +++ /dev/null @@ -1,2 +0,0 @@ -# This file is not meant for public use and will be removed in SciPy v2.0.0. -__all__ = () diff --git a/scipy-stubs/optimize/elementwise.pyi b/scipy-stubs/optimize/elementwise.pyi deleted file mode 100644 index 4c2390a8..00000000 --- a/scipy-stubs/optimize/elementwise.pyi +++ /dev/null @@ -1,6 +0,0 @@ -from ._elementwise import ( - bracket_minimum as bracket_minimum, - bracket_root as bracket_root, - find_minimum as find_minimum, - find_root as find_root, -) diff --git a/scipy-stubs/spatial/transform/rotation.pyi b/scipy-stubs/spatial/transform/rotation.pyi index 3d355e14..ac7e1f0e 100644 --- a/scipy-stubs/spatial/transform/rotation.pyi +++ b/scipy-stubs/spatial/transform/rotation.pyi @@ -1,3 +1,3 @@ from ._rotation import Rotation, Slerp -__all__ = "Rotation", "Slerp" +__all__ = ["Rotation", "Slerp"] diff --git a/stubtest.txt b/stubtest.txt index 681f5a85..464ae193 100644 --- a/stubtest.txt +++ b/stubtest.txt @@ -4,7 +4,6 @@ scipy._lib._ccallback.CFFIVoidP(B is not present at runtime scipy._lib._ccallback.LowLevelCallable.__getitem__(B variable differs from runtime type def (self: Untyped, idx: Untyped) -> Untyped scipy._lib._ccallback.PyCFuncPtr(B cannot be subclassed at runtime, but isn't marked with @final in the stub -scipy._lib._ccallback.__all__(B is not present at runtime scipy._lib._highs_utils(B failed to import. Maybe install the runtime package or alter PYTHONPATH? ModuleNotFoundError: No module named 'scipy._lib._highs_utils' scipy._lib._pep440.Infinity(B is not a type scipy._lib._pep440.NegativeInfinity(B is not a type @@ -56,178 +55,7 @@ scipy._lib._util.Generator.weibull(B is not present in stub scipy._lib._util.Generator.zipf(B is not present in stub scipy._lib._util.SeedType(B is not present at runtime -scipy._lib.array_api_compat.__all__(B is not present at runtime -scipy._lib.array_api_compat.common.__all__(B is not present at runtime scipy._lib.decorator.ContextManager.__init__(B is inconsistent, stub argument "func" differs from runtime argument "g" -scipy.constants.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.constants.codata(B is not present in stub -scipy.constants.constants(B is not present in stub -scipy.constants.codata.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.constants.codata.ConstantWarning(B is not present in stub -scipy.constants.codata.__all__(B variable differs from runtime type list[Untyped] -scipy.constants.codata.c(B is not present in stub -scipy.constants.codata.find(B is not present in stub -scipy.constants.codata.k(B is not present in stub -scipy.constants.codata.physical_constants(B is not present in stub -scipy.constants.codata.precision(B is not present in stub -scipy.constants.codata.unit(B is not present in stub -scipy.constants.codata.value(B is not present in stub -scipy.constants.constants.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.constants.constants.Avogadro(B is not present in stub -scipy.constants.constants.Boltzmann(B is not present in stub -scipy.constants.constants.Btu(B is not present in stub -scipy.constants.constants.Btu_IT(B is not present in stub -scipy.constants.constants.Btu_th(B is not present in stub -scipy.constants.constants.G(B is not present in stub -scipy.constants.constants.Julian_year(B is not present in stub -scipy.constants.constants.N_A(B is not present in stub -scipy.constants.constants.Planck(B is not present in stub -scipy.constants.constants.R(B is not present in stub -scipy.constants.constants.Rydberg(B is not present in stub -scipy.constants.constants.Stefan_Boltzmann(B is not present in stub -scipy.constants.constants.Wien(B is not present in stub -scipy.constants.constants.__all__(B variable differs from runtime type list[Untyped] -scipy.constants.constants.acre(B is not present in stub -scipy.constants.constants.alpha(B is not present in stub -scipy.constants.constants.angstrom(B is not present in stub -scipy.constants.constants.arcmin(B is not present in stub -scipy.constants.constants.arcminute(B is not present in stub -scipy.constants.constants.arcsec(B is not present in stub -scipy.constants.constants.arcsecond(B is not present in stub -scipy.constants.constants.astronomical_unit(B is not present in stub -scipy.constants.constants.atm(B is not present in stub -scipy.constants.constants.atmosphere(B is not present in stub -scipy.constants.constants.atomic_mass(B is not present in stub -scipy.constants.constants.atto(B is not present in stub -scipy.constants.constants.au(B is not present in stub -scipy.constants.constants.bar(B is not present in stub -scipy.constants.constants.barrel(B is not present in stub -scipy.constants.constants.bbl(B is not present in stub -scipy.constants.constants.blob(B is not present in stub -scipy.constants.constants.c(B is not present in stub -scipy.constants.constants.calorie(B is not present in stub -scipy.constants.constants.calorie_IT(B is not present in stub -scipy.constants.constants.calorie_th(B is not present in stub -scipy.constants.constants.carat(B is not present in stub -scipy.constants.constants.centi(B is not present in stub -scipy.constants.constants.convert_temperature(B is not present in stub -scipy.constants.constants.day(B is not present in stub -scipy.constants.constants.deci(B is not present in stub -scipy.constants.constants.degree(B is not present in stub -scipy.constants.constants.degree_Fahrenheit(B is not present in stub -scipy.constants.constants.deka(B is not present in stub -scipy.constants.constants.dyn(B is not present in stub -scipy.constants.constants.dyne(B is not present in stub -scipy.constants.constants.e(B is not present in stub -scipy.constants.constants.eV(B is not present in stub -scipy.constants.constants.electron_mass(B is not present in stub -scipy.constants.constants.electron_volt(B is not present in stub -scipy.constants.constants.elementary_charge(B is not present in stub -scipy.constants.constants.epsilon_0(B is not present in stub -scipy.constants.constants.erg(B is not present in stub -scipy.constants.constants.exa(B is not present in stub -scipy.constants.constants.exbi(B is not present in stub -scipy.constants.constants.femto(B is not present in stub -scipy.constants.constants.fermi(B is not present in stub -scipy.constants.constants.fine_structure(B is not present in stub -scipy.constants.constants.fluid_ounce(B is not present in stub -scipy.constants.constants.fluid_ounce_US(B is not present in stub -scipy.constants.constants.fluid_ounce_imp(B is not present in stub -scipy.constants.constants.foot(B is not present in stub -scipy.constants.constants.g(B is not present in stub -scipy.constants.constants.gallon(B is not present in stub -scipy.constants.constants.gallon_US(B is not present in stub -scipy.constants.constants.gallon_imp(B is not present in stub -scipy.constants.constants.gas_constant(B is not present in stub -scipy.constants.constants.gibi(B is not present in stub -scipy.constants.constants.giga(B is not present in stub -scipy.constants.constants.golden(B is not present in stub -scipy.constants.constants.golden_ratio(B is not present in stub -scipy.constants.constants.grain(B is not present in stub -scipy.constants.constants.gram(B is not present in stub -scipy.constants.constants.gravitational_constant(B is not present in stub -scipy.constants.constants.h(B is not present in stub -scipy.constants.constants.hbar(B is not present in stub -scipy.constants.constants.hectare(B is not present in stub -scipy.constants.constants.hecto(B is not present in stub -scipy.constants.constants.horsepower(B is not present in stub -scipy.constants.constants.hour(B is not present in stub -scipy.constants.constants.hp(B is not present in stub -scipy.constants.constants.inch(B is not present in stub -scipy.constants.constants.k(B is not present in stub -scipy.constants.constants.kgf(B is not present in stub -scipy.constants.constants.kibi(B is not present in stub -scipy.constants.constants.kilo(B is not present in stub -scipy.constants.constants.kilogram_force(B is not present in stub -scipy.constants.constants.kmh(B is not present in stub -scipy.constants.constants.knot(B is not present in stub -scipy.constants.constants.lambda2nu(B is not present in stub -scipy.constants.constants.lb(B is not present in stub -scipy.constants.constants.lbf(B is not present in stub -scipy.constants.constants.light_year(B is not present in stub -scipy.constants.constants.liter(B is not present in stub -scipy.constants.constants.litre(B is not present in stub -scipy.constants.constants.long_ton(B is not present in stub -scipy.constants.constants.m_e(B is not present in stub -scipy.constants.constants.m_n(B is not present in stub -scipy.constants.constants.m_p(B is not present in stub -scipy.constants.constants.m_u(B is not present in stub -scipy.constants.constants.mach(B is not present in stub -scipy.constants.constants.mebi(B is not present in stub -scipy.constants.constants.mega(B is not present in stub -scipy.constants.constants.metric_ton(B is not present in stub -scipy.constants.constants.micro(B is not present in stub -scipy.constants.constants.micron(B is not present in stub -scipy.constants.constants.mil(B is not present in stub -scipy.constants.constants.mile(B is not present in stub -scipy.constants.constants.milli(B is not present in stub -scipy.constants.constants.minute(B is not present in stub -scipy.constants.constants.mmHg(B is not present in stub -scipy.constants.constants.mph(B is not present in stub -scipy.constants.constants.mu_0(B is not present in stub -scipy.constants.constants.nano(B is not present in stub -scipy.constants.constants.nautical_mile(B is not present in stub -scipy.constants.constants.neutron_mass(B is not present in stub -scipy.constants.constants.nu2lambda(B is not present in stub -scipy.constants.constants.ounce(B is not present in stub -scipy.constants.constants.oz(B is not present in stub -scipy.constants.constants.parsec(B is not present in stub -scipy.constants.constants.pebi(B is not present in stub -scipy.constants.constants.peta(B is not present in stub -scipy.constants.constants.pi(B is not present in stub -scipy.constants.constants.pico(B is not present in stub -scipy.constants.constants.point(B is not present in stub -scipy.constants.constants.pound(B is not present in stub -scipy.constants.constants.pound_force(B is not present in stub -scipy.constants.constants.proton_mass(B is not present in stub -scipy.constants.constants.psi(B is not present in stub -scipy.constants.constants.pt(B is not present in stub -scipy.constants.constants.short_ton(B is not present in stub -scipy.constants.constants.sigma(B is not present in stub -scipy.constants.constants.slinch(B is not present in stub -scipy.constants.constants.slug(B is not present in stub -scipy.constants.constants.speed_of_light(B is not present in stub -scipy.constants.constants.speed_of_sound(B is not present in stub -scipy.constants.constants.stone(B is not present in stub -scipy.constants.constants.survey_foot(B is not present in stub -scipy.constants.constants.survey_mile(B is not present in stub -scipy.constants.constants.tebi(B is not present in stub -scipy.constants.constants.tera(B is not present in stub -scipy.constants.constants.ton_TNT(B is not present in stub -scipy.constants.constants.torr(B is not present in stub -scipy.constants.constants.troy_ounce(B is not present in stub -scipy.constants.constants.troy_pound(B is not present in stub -scipy.constants.constants.u(B is not present in stub -scipy.constants.constants.week(B is not present in stub -scipy.constants.constants.yard(B is not present in stub -scipy.constants.constants.year(B is not present in stub -scipy.constants.constants.yobi(B is not present in stub -scipy.constants.constants.yocto(B is not present in stub -scipy.constants.constants.yotta(B is not present in stub -scipy.constants.constants.zebi(B is not present in stub -scipy.constants.constants.zepto(B is not present in stub -scipy.constants.constants.zero_Celsius(B is not present in stub -scipy.constants.constants.zetta(B is not present in stub scipy.fftpack.basic.fft(B is not present in stub scipy.fftpack.basic.fft2(B is not present in stub scipy.fftpack.basic.fftn(B is not present in stub @@ -260,7 +88,6 @@ scipy.fftpack.realtransforms.idctn(B is not present in stub scipy.fftpack.realtransforms.idst(B is not present in stub scipy.fftpack.realtransforms.idstn(B is not present in stub -scipy.integrate.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.integrate.dblquad(B is inconsistent, runtime argument "args" has a default value of type (), which is incompatible with stub argument type (Unpack[_Ts`-1 = Unpack[()]],) scipy.integrate.dblquad(B is inconsistent, runtime argument "epsabs" is not keyword-only scipy.integrate.dblquad(B is inconsistent, runtime argument "epsrel" is not keyword-only @@ -320,7 +147,6 @@ scipy.integrate._bvp.solve_newton(B is not present in stub scipy.integrate._bvp.stacked_matmul(B is not present in stub scipy.integrate._bvp.wrap_functions(B is not present in stub -scipy.integrate._ivp.__all__(B is not present at runtime scipy.integrate._ivp.ivp.prepare_events(B is inconsistent, runtime does not have argument "t0" scipy.integrate._ode.IntegratorBase.scalar(B variable differs from runtime type type scipy.integrate._ode.dop853.success(B variable differs from runtime type None @@ -378,17 +204,6 @@ scipy.integrate._quadpack_py.tplquad(B is inconsistent, runtime argument "epsrel" is not keyword-only scipy.integrate._quadrature.fixed_quad(B is inconsistent, runtime argument "args" has a default value of type (), which is incompatible with stub argument type (Unpack[_Ts`-2 = Unpack[()]],) scipy.integrate._tanhsinh.nsum(B is not present at runtime -scipy.integrate.lsoda.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.integrate.lsoda.lsoda(B is not present in stub -scipy.integrate.odepack.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.integrate.odepack.ODEintWarning(B is not present in stub -scipy.integrate.odepack.odeint(B is not present in stub -scipy.integrate.quadpack.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.integrate.quadpack.IntegrationWarning(B is not present in stub -scipy.integrate.quadpack.dblquad(B is not present in stub -scipy.integrate.quadpack.nquad(B is not present in stub -scipy.integrate.quadpack.quad(B is not present in stub -scipy.integrate.quadpack.tplquad(B is not present in stub scipy.interpolate.InterpolatedUnivariateSpline.__init__(B is inconsistent, runtime argument "w" is not keyword-only scipy.interpolate.InterpolatedUnivariateSpline.__init__(B is inconsistent, runtime argument "bbox" is not keyword-only scipy.interpolate.InterpolatedUnivariateSpline.__init__(B is inconsistent, runtime argument "k" is not keyword-only @@ -645,14 +460,8 @@ scipy.io.mmio.mmwrite(B is not present in stub scipy.io.netcdf.netcdf_file(B is not present in stub scipy.io.netcdf.netcdf_variable(B is not present in stub -scipy.linalg.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.linalg.cython_blas(B is not present in stub scipy.linalg.cython_lapack(B is not present in stub -scipy.linalg.decomp_cholesky(B is not present in stub -scipy.linalg.decomp_lu(B is not present in stub -scipy.linalg.decomp_qr(B is not present in stub -scipy.linalg.decomp_schur(B is not present in stub -scipy.linalg.decomp_svd(B is not present in stub scipy.linalg.eig(B is inconsistent, stub argument "a" has a default value but runtime argument does not scipy.linalg.eig(B is inconsistent, stub argument "a" differs from runtime argument "b" scipy.linalg.eig(B is inconsistent, runtime argument "b" has a default value of type None, which is incompatible with stub argument type numpy._typing._array_like._SupportsArray[numpy.dtype[Any]] | numpy._typing._nested_sequence._NestedSequence[numpy._typing._array_like._SupportsArray[numpy.dtype[Any]]] | int | float | complex | str | bytes | numpy._typing._nested_sequence._NestedSequence[bool | int | float | complex | str | bytes]. This is often caused by overloads failing to account for explicitly passing in the default value. @@ -713,7 +522,6 @@ scipy.linalg.lu(B is inconsistent, runtime does not have argument "check_finite" scipy.linalg.lu(B is inconsistent, runtime does not have argument "p_indices" scipy.linalg.lu(B is inconsistent, runtime does not have argument "p_indices" -scipy.linalg.matfuncs(B is not present in stub scipy.linalg.matmul_toeplitz(B is inconsistent, runtime argument "check_finite" has a default value of False, which is different from stub argument default True scipy.linalg.matrix_balance(B is inconsistent, stub argument "A" has a default value but runtime argument does not scipy.linalg.matrix_balance(B is inconsistent, stub argument "A" differs from runtime argument "permute" @@ -724,7 +532,6 @@ scipy.linalg.matrix_balance(B is inconsistent, runtime does not have argument "separate" scipy.linalg.matrix_balance(B is inconsistent, runtime does not have argument "separate" scipy.linalg.matrix_balance(B is inconsistent, runtime does not have argument "overwrite_a" -scipy.linalg.misc(B is not present in stub scipy.linalg.null_space(B is inconsistent, runtime does not have argument "check_finite" scipy.linalg.null_space(B is inconsistent, runtime does not have argument "lapack_driver" scipy.linalg.null_space(B is inconsistent, runtime does not have argument "overwrite_a" @@ -787,7 +594,6 @@ scipy.linalg.rq(B is inconsistent, runtime does not have argument "mode" scipy.linalg.rq(B is inconsistent, runtime does not have argument "check_finite" scipy.linalg.solve(B is inconsistent, runtime argument "assume_a" has a default value of 'gen', which is different from stub argument default None -scipy.linalg.special_matrices(B is not present in stub scipy.linalg.svd(B is inconsistent, stub argument "a" has a default value but runtime argument does not scipy.linalg.svd(B is inconsistent, stub argument "a" differs from runtime argument "full_matrices" scipy.linalg.svd(B is inconsistent, stub argument "full_matrices" differs from runtime argument "compute_uv" @@ -862,7 +668,6 @@ scipy.linalg._decomp_lu.lu(B is inconsistent, runtime does not have argument "check_finite" scipy.linalg._decomp_lu.lu(B is inconsistent, runtime does not have argument "p_indices" scipy.linalg._decomp_lu.lu(B is inconsistent, runtime does not have argument "p_indices" -scipy.linalg._decomp_lu_cython.__all__(B is not present at runtime scipy.linalg._decomp_lu_cython.lu_decompose(B is not present at runtime scipy.linalg._decomp_lu_cython.lu_dispatcher(B is inconsistent, stub argument "lu" differs from runtime argument "u" scipy.linalg._decomp_lu_cython.lu_dispatcher(B is inconsistent, stub argument "perm" differs from runtime argument "piv" @@ -942,7 +747,6 @@ scipy.linalg._matfuncs.expm_frechet(B is inconsistent, runtime does not have argument "compute_expm" scipy.linalg._matfuncs.expm_frechet(B is inconsistent, runtime does not have argument "check_finite" scipy.linalg._matfuncs_expm.pick_pade_structure(B is inconsistent, stub argument "a" differs from runtime argument "Am" -scipy.linalg._solve_toeplitz.__all__(B is not present at runtime scipy.linalg._special_matrices.invpascal(B is inconsistent, stub argument "n" has a default value but runtime argument does not scipy.linalg._special_matrices.invpascal(B is inconsistent, stub argument "n" differs from runtime argument "kind" scipy.linalg._special_matrices.invpascal(B is inconsistent, runtime argument "kind" has a default value of type 'symmetric', which is incompatible with stub argument type int | numpy.integer[numpy._typing.NBitBase] | numpy.bool. This is often caused by overloads failing to account for explicitly passing in the default value. @@ -959,134 +763,12 @@ scipy.linalg._special_matrices.pascal(B is inconsistent, runtime does not have argument "kind" scipy.linalg._special_matrices.pascal(B is inconsistent, runtime does not have argument "exact" scipy.linalg._special_matrices.pascal(B is inconsistent, runtime does not have argument "exact" -scipy.linalg.basic.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.basic.LinAlgError(B is not present in stub -scipy.linalg.basic.LinAlgWarning(B is not present in stub -scipy.linalg.basic.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.basic.det(B is not present in stub -scipy.linalg.basic.get_lapack_funcs(B is not present in stub -scipy.linalg.basic.inv(B is not present in stub -scipy.linalg.basic.lstsq(B is not present in stub -scipy.linalg.basic.matmul_toeplitz(B is not present in stub -scipy.linalg.basic.matrix_balance(B is not present in stub -scipy.linalg.basic.pinv(B is not present in stub -scipy.linalg.basic.pinvh(B is not present in stub -scipy.linalg.basic.solve(B is not present in stub -scipy.linalg.basic.solve_banded(B is not present in stub -scipy.linalg.basic.solve_circulant(B is not present in stub -scipy.linalg.basic.solve_toeplitz(B is not present in stub -scipy.linalg.basic.solve_triangular(B is not present in stub -scipy.linalg.basic.solveh_banded(B is not present in stub -scipy.linalg.decomp.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.decomp.LinAlgError(B is not present in stub -scipy.linalg.decomp.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.decomp.cdf2rdf(B is not present in stub -scipy.linalg.decomp.eig(B is not present in stub -scipy.linalg.decomp.eig_banded(B is not present in stub -scipy.linalg.decomp.eigh(B is not present in stub -scipy.linalg.decomp.eigh_tridiagonal(B is not present in stub -scipy.linalg.decomp.eigvals(B is not present in stub -scipy.linalg.decomp.eigvals_banded(B is not present in stub -scipy.linalg.decomp.eigvalsh(B is not present in stub -scipy.linalg.decomp.eigvalsh_tridiagonal(B is not present in stub -scipy.linalg.decomp.get_lapack_funcs(B is not present in stub -scipy.linalg.decomp.hessenberg(B is not present in stub -scipy.linalg.decomp.norm(B is not present in stub -scipy.linalg.decomp_cholesky.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.decomp_cholesky.LinAlgError(B is not present in stub -scipy.linalg.decomp_cholesky.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.decomp_cholesky.cho_factor(B is not present in stub -scipy.linalg.decomp_cholesky.cho_solve(B is not present in stub -scipy.linalg.decomp_cholesky.cho_solve_banded(B is not present in stub -scipy.linalg.decomp_cholesky.cholesky(B is not present in stub -scipy.linalg.decomp_cholesky.cholesky_banded(B is not present in stub -scipy.linalg.decomp_cholesky.get_lapack_funcs(B is not present in stub -scipy.linalg.decomp_lu.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.decomp_lu.LinAlgWarning(B is not present in stub -scipy.linalg.decomp_lu.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.decomp_lu.get_lapack_funcs(B is not present in stub -scipy.linalg.decomp_lu.lu(B is not present in stub -scipy.linalg.decomp_lu.lu_factor(B is not present in stub -scipy.linalg.decomp_lu.lu_solve(B is not present in stub -scipy.linalg.decomp_qr.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.decomp_qr.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.decomp_qr.get_lapack_funcs(B is not present in stub -scipy.linalg.decomp_qr.qr(B is not present in stub -scipy.linalg.decomp_qr.qr_multiply(B is not present in stub -scipy.linalg.decomp_qr.rq(B is not present in stub -scipy.linalg.decomp_schur.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.decomp_schur.LinAlgError(B is not present in stub -scipy.linalg.decomp_schur.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.decomp_schur.eigvals(B is not present in stub -scipy.linalg.decomp_schur.get_lapack_funcs(B is not present in stub -scipy.linalg.decomp_schur.norm(B is not present in stub -scipy.linalg.decomp_schur.rsf2csf(B is not present in stub -scipy.linalg.decomp_schur.schur(B is not present in stub -scipy.linalg.decomp_svd.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.decomp_svd.LinAlgError(B is not present in stub -scipy.linalg.decomp_svd.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.decomp_svd.diagsvd(B is not present in stub -scipy.linalg.decomp_svd.get_lapack_funcs(B is not present in stub -scipy.linalg.decomp_svd.null_space(B is not present in stub -scipy.linalg.decomp_svd.orth(B is not present in stub -scipy.linalg.decomp_svd.subspace_angles(B is not present in stub -scipy.linalg.decomp_svd.svd(B is not present in stub -scipy.linalg.decomp_svd.svdvals(B is not present in stub scipy.linalg.interpolative.estimate_rank(B is inconsistent, runtime does not have argument "rng" scipy.linalg.interpolative.estimate_spectral_norm(B is inconsistent, runtime does not have argument "rng" scipy.linalg.interpolative.estimate_spectral_norm_diff(B is inconsistent, runtime does not have argument "rng" scipy.linalg.interpolative.interp_decomp(B is inconsistent, runtime does not have argument "rng" scipy.linalg.interpolative.seed(B is inconsistent, runtime argument "seed" has a default value of type None, which is incompatible with stub argument type Never scipy.linalg.interpolative.svd(B is inconsistent, runtime does not have argument "rng" -scipy.linalg.matfuncs.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.matfuncs.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.matfuncs.coshm(B is not present in stub -scipy.linalg.matfuncs.cosm(B is not present in stub -scipy.linalg.matfuncs.expm(B is not present in stub -scipy.linalg.matfuncs.expm_cond(B is not present in stub -scipy.linalg.matfuncs.expm_frechet(B is not present in stub -scipy.linalg.matfuncs.fractional_matrix_power(B is not present in stub -scipy.linalg.matfuncs.funm(B is not present in stub -scipy.linalg.matfuncs.inv(B is not present in stub -scipy.linalg.matfuncs.khatri_rao(B is not present in stub -scipy.linalg.matfuncs.logm(B is not present in stub -scipy.linalg.matfuncs.norm(B is not present in stub -scipy.linalg.matfuncs.rsf2csf(B is not present in stub -scipy.linalg.matfuncs.schur(B is not present in stub -scipy.linalg.matfuncs.signm(B is not present in stub -scipy.linalg.matfuncs.sinhm(B is not present in stub -scipy.linalg.matfuncs.sinm(B is not present in stub -scipy.linalg.matfuncs.solve(B is not present in stub -scipy.linalg.matfuncs.sqrtm(B is not present in stub -scipy.linalg.matfuncs.svd(B is not present in stub -scipy.linalg.matfuncs.tanhm(B is not present in stub -scipy.linalg.matfuncs.tanm(B is not present in stub -scipy.linalg.misc.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.misc.LinAlgError(B is not present in stub -scipy.linalg.misc.LinAlgWarning(B is not present in stub -scipy.linalg.misc.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.misc.get_blas_funcs(B is not present in stub -scipy.linalg.misc.get_lapack_funcs(B is not present in stub -scipy.linalg.misc.norm(B is not present in stub -scipy.linalg.special_matrices.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub -scipy.linalg.special_matrices.__all__(B variable differs from runtime type list[Untyped] -scipy.linalg.special_matrices.block_diag(B is not present in stub -scipy.linalg.special_matrices.circulant(B is not present in stub -scipy.linalg.special_matrices.companion(B is not present in stub -scipy.linalg.special_matrices.convolution_matrix(B is not present in stub -scipy.linalg.special_matrices.dft(B is not present in stub -scipy.linalg.special_matrices.fiedler(B is not present in stub -scipy.linalg.special_matrices.fiedler_companion(B is not present in stub -scipy.linalg.special_matrices.hadamard(B is not present in stub -scipy.linalg.special_matrices.hankel(B is not present in stub -scipy.linalg.special_matrices.helmert(B is not present in stub -scipy.linalg.special_matrices.hilbert(B is not present in stub -scipy.linalg.special_matrices.invhilbert(B is not present in stub -scipy.linalg.special_matrices.invpascal(B is not present in stub -scipy.linalg.special_matrices.kron(B is not present in stub -scipy.linalg.special_matrices.leslie(B is not present in stub -scipy.linalg.special_matrices.pascal(B is not present in stub -scipy.linalg.special_matrices.toeplitz(B is not present in stub scipy.misc.common.ascent(B is not present in stub scipy.misc.common.central_diff_weights(B is not present in stub scipy.misc.common.derivative(B is not present in stub @@ -1198,10 +880,9 @@ scipy.odr.odrpack.odr_stop(B is not present in stub scipy.optimize.KrylovJacobian.setup(B is inconsistent, stub argument "F" differs from runtime argument "f" scipy.optimize.KrylovJacobian.update(B is inconsistent, stub argument "F" differs from runtime argument "f" -scipy.optimize.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None -scipy.optimize._constraints.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None -scipy.optimize._constraints.__all__(B is not present at runtime -scipy.optimize._differentialevolution.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None +scipy.optimize.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None +scipy.optimize._constraints.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None +scipy.optimize._differentialevolution.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None scipy.optimize._elementwise(B failed to import. Maybe install the runtime package or alter PYTHONPATH? ModuleNotFoundError: No module named 'scipy.optimize._elementwise' scipy.optimize._group_columns.__pythran__(B is not present in stub scipy.optimize._highs.cython(B failed to import. Maybe install the runtime package or alter PYTHONPATH? ModuleNotFoundError: No module named 'scipy.optimize._highs.cython' @@ -1215,7 +896,6 @@ scipy.optimize._linprog_util._LPProblem.__new__(B is inconsistent, runtime argument "bounds" has a default value but stub argument does not scipy.optimize._linprog_util._LPProblem.__new__(B is inconsistent, runtime argument "x0" has a default value but stub argument does not scipy.optimize._linprog_util._LPProblem.__new__(B is inconsistent, runtime argument "integrality" has a default value but stub argument does not -scipy.optimize._lsap.__all__(B is not present at runtime scipy.optimize._lsq.least_squares(B is inconsistent, runtime argument "tr_options" has a default value of {}, which is different from stub argument default None scipy.optimize._lsq.least_squares(B is inconsistent, runtime argument "kwargs" has a default value of {}, which is different from stub argument default None scipy.optimize._lsq.common.LinearOperator.__new__(B is inconsistent, stub does not have *args argument "args" @@ -1256,80 +936,17 @@ scipy.optimize._nonlin.KrylovJacobian.update(B is inconsistent, stub argument "F" differs from runtime argument "f" scipy.optimize._numdiff.approx_derivative(B is inconsistent, runtime argument "kwargs" has a default value of {}, which is different from stub argument default None scipy.optimize._numdiff.check_derivative(B is inconsistent, runtime argument "kwargs" has a default value of {}, which is different from stub argument default None -scipy.optimize._remove_redundancy.__all__(B is not present at runtime -scipy.optimize._trlib._trlib.__all__(B is not present at runtime scipy.optimize._trustregion_constr._minimize_trustregion_constr(B is not present in stub scipy.optimize._trustregion_constr.minimize_trustregion_constr.LagrangianHessian.__call__(B is inconsistent, stub argument "v_ineq" has a default value but runtime argument does not scipy.optimize._trustregion_constr.minimize_trustregion_constr.LinearOperator.__new__(B is inconsistent, stub does not have *args argument "args" scipy.optimize._trustregion_constr.minimize_trustregion_constr.LinearOperator.dtype(B is not present at runtime -scipy.optimize._trustregion_constr.minimize_trustregion_constr.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None +scipy.optimize._trustregion_constr.minimize_trustregion_constr.NonlinearConstraint.__init__(B is inconsistent, runtime argument "hess" has a default value of , which is different from stub argument default None scipy.optimize._trustregion_constr.projections.LinearOperator.__new__(B is inconsistent, stub does not have *args argument "args" scipy.optimize._trustregion_constr.projections.LinearOperator.dtype(B is not present at runtime scipy.optimize._trustregion_constr.tr_interior_point.LinearOperator.__new__(B is inconsistent, stub does not have *args argument "args" scipy.optimize._trustregion_constr.tr_interior_point.LinearOperator.dtype(B is not present at runtime scipy.optimize._trustregion_exact._minimize_trustregion_exact(B is not present in stub scipy.optimize._trustregion_krylov._minimize_trust_krylov(B is not present in stub -scipy.optimize.cobyla.OptimizeResult(B is not present in stub -scipy.optimize.cobyla.fmin_cobyla(B is not present in stub -scipy.optimize.elementwise(B failed to import. Maybe install the runtime package or alter PYTHONPATH? ModuleNotFoundError: No module named 'scipy.optimize.elementwise' -scipy.optimize.lbfgsb.LbfgsInvHessProduct(B is not present in stub -scipy.optimize.lbfgsb.OptimizeResult(B is not present in stub -scipy.optimize.lbfgsb.fmin_l_bfgs_b(B is not present in stub -scipy.optimize.lbfgsb.zeros(B is not present in stub -scipy.optimize.linesearch.line_search(B is not present in stub -scipy.optimize.minpack.OptimizeResult(B is not present in stub -scipy.optimize.minpack.OptimizeWarning(B is not present in stub -scipy.optimize.minpack.curve_fit(B is not present in stub -scipy.optimize.minpack.fixed_point(B is not present in stub -scipy.optimize.minpack.fsolve(B is not present in stub -scipy.optimize.minpack.least_squares(B is not present in stub -scipy.optimize.minpack.leastsq(B is not present in stub -scipy.optimize.minpack.zeros(B is not present in stub -scipy.optimize.nonlin.BroydenFirst(B is not present in stub -scipy.optimize.nonlin.InverseJacobian(B is not present in stub -scipy.optimize.nonlin.KrylovJacobian(B is not present in stub -scipy.optimize.nonlin.anderson(B is not present in stub -scipy.optimize.nonlin.broyden1(B is not present in stub -scipy.optimize.nonlin.broyden2(B is not present in stub -scipy.optimize.nonlin.diagbroyden(B is not present in stub -scipy.optimize.nonlin.excitingmixing(B is not present in stub -scipy.optimize.nonlin.linearmixing(B is not present in stub -scipy.optimize.nonlin.newton_krylov(B is not present in stub -scipy.optimize.optimize.OptimizeResult(B is not present in stub -scipy.optimize.optimize.OptimizeWarning(B is not present in stub -scipy.optimize.optimize.approx_fprime(B is not present in stub -scipy.optimize.optimize.bracket(B is not present in stub -scipy.optimize.optimize.brent(B is not present in stub -scipy.optimize.optimize.brute(B is not present in stub -scipy.optimize.optimize.check_grad(B is not present in stub -scipy.optimize.optimize.fmin(B is not present in stub -scipy.optimize.optimize.fmin_bfgs(B is not present in stub -scipy.optimize.optimize.fmin_cg(B is not present in stub -scipy.optimize.optimize.fmin_ncg(B is not present in stub -scipy.optimize.optimize.fmin_powell(B is not present in stub -scipy.optimize.optimize.fminbound(B is not present in stub -scipy.optimize.optimize.golden(B is not present in stub -scipy.optimize.optimize.line_search(B is not present in stub -scipy.optimize.optimize.rosen(B is not present in stub -scipy.optimize.optimize.rosen_der(B is not present in stub -scipy.optimize.optimize.rosen_hess(B is not present in stub -scipy.optimize.optimize.rosen_hess_prod(B is not present in stub -scipy.optimize.optimize.show_options(B is not present in stub -scipy.optimize.optimize.zeros(B is not present in stub -scipy.optimize.slsqp.OptimizeResult(B is not present in stub -scipy.optimize.slsqp.fmin_slsqp(B is not present in stub -scipy.optimize.slsqp.slsqp(B is not present in stub -scipy.optimize.slsqp.zeros(B is not present in stub -scipy.optimize.tnc.OptimizeResult(B is not present in stub -scipy.optimize.tnc.fmin_tnc(B is not present in stub -scipy.optimize.tnc.zeros(B is not present in stub -scipy.optimize.zeros.RootResults(B is not present in stub -scipy.optimize.zeros.bisect(B is not present in stub -scipy.optimize.zeros.brenth(B is not present in stub -scipy.optimize.zeros.brentq(B is not present in stub -scipy.optimize.zeros.newton(B is not present in stub -scipy.optimize.zeros.ridder(B is not present in stub -scipy.optimize.zeros.toms748(B is not present in stub scipy.signal.BSpline(B is not present at runtime scipy.signal.EPSILON(B is not present at runtime scipy.signal.LinAlgError(B is not present at runtime @@ -1377,7 +994,6 @@ scipy.signal._max_len_seq_inner.__pythran__(B is not present in stub scipy.signal._short_time_fft.FFT_MODE_TYPE(B is not a Union scipy.signal._short_time_fft.PAD_TYPE(B is not a Union -scipy.signal._signaltools.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.signal._signaltools.cmplx_sort(B is not present in stub scipy.signal._spectral.__pythran__(B is not present in stub scipy.signal._spline.cspline2d(B is not present in stub @@ -1633,7 +1249,6 @@ scipy.sparse._index.INT_TYPES(B is not present in stub scipy.sparse._lil._lil_base.__init__(B is inconsistent, runtime does not have argument "maxprint" scipy.sparse._lil._lil_base.count_nonzero(B is inconsistent, runtime does not have argument "axis" -scipy.sparse._matrix.__all__(B is not present at runtime scipy.sparse._matrix.spmatrix.todense(B is not present at runtime scipy.sparse._sputils.convert_pydata_sparse_to_scipy(B is inconsistent, runtime does not have argument "accept_fv" scipy.sparse.base.MAXPRINT(B is not present in stub @@ -1740,7 +1355,6 @@ scipy.sparse.csc.isspmatrix_csc(B is not present in stub scipy.sparse.csc.spmatrix(B is not present in stub scipy.sparse.csc.upcast(B is not present in stub -scipy.sparse.csgraph.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.sparse.csgraph.NegativeCycleError.__init__(B is inconsistent, stub does not have argument "message" scipy.sparse.csgraph.NegativeCycleError.__init__(B is inconsistent, runtime does not have *args argument "args" scipy.sparse.csgraph.bellman_ford(B is inconsistent, stub does not have argument "csgraph" @@ -1879,15 +1493,12 @@ scipy.sparse.csgraph.yen(B is inconsistent, stub does not have argument "unweighted" scipy.sparse.csgraph.yen(B is inconsistent, runtime does not have **kwargs argument "kwargs" scipy.sparse.csgraph._flow.MaximumFlowResult(B is not present in stub -scipy.sparse.csgraph._flow.__all__(B is not present at runtime scipy.sparse.csgraph._flow.maximum_flow(B is inconsistent, stub does not have argument "csgraph" scipy.sparse.csgraph._flow.maximum_flow(B is inconsistent, stub does not have argument "source" scipy.sparse.csgraph._flow.maximum_flow(B is inconsistent, stub does not have argument "sink" scipy.sparse.csgraph._flow.maximum_flow(B is inconsistent, runtime does not have *args argument "args" scipy.sparse.csgraph._flow.maximum_flow(B is inconsistent, stub does not have argument "method" scipy.sparse.csgraph._flow.maximum_flow(B is inconsistent, runtime does not have **kwargs argument "kwargs" -scipy.sparse.csgraph._laplacian.__all__(B is not present at runtime -scipy.sparse.csgraph._matching.__all__(B is not present at runtime scipy.sparse.csgraph._matching.maximum_bipartite_matching(B is inconsistent, stub does not have argument "graph" scipy.sparse.csgraph._matching.maximum_bipartite_matching(B is inconsistent, stub does not have argument "perm_type" scipy.sparse.csgraph._matching.maximum_bipartite_matching(B is inconsistent, runtime does not have *args argument "args" @@ -1896,12 +1507,10 @@ scipy.sparse.csgraph._matching.min_weight_full_bipartite_matching(B is inconsistent, stub does not have argument "maximize" scipy.sparse.csgraph._matching.min_weight_full_bipartite_matching(B is inconsistent, runtime does not have *args argument "args" scipy.sparse.csgraph._matching.min_weight_full_bipartite_matching(B is inconsistent, runtime does not have **kwargs argument "kwargs" -scipy.sparse.csgraph._min_spanning_tree.__all__(B is not present at runtime scipy.sparse.csgraph._min_spanning_tree.minimum_spanning_tree(B is inconsistent, stub does not have argument "csgraph" scipy.sparse.csgraph._min_spanning_tree.minimum_spanning_tree(B is inconsistent, stub does not have argument "overwrite" scipy.sparse.csgraph._min_spanning_tree.minimum_spanning_tree(B is inconsistent, runtime does not have *args argument "args" scipy.sparse.csgraph._min_spanning_tree.minimum_spanning_tree(B is inconsistent, runtime does not have **kwargs argument "kwargs" -scipy.sparse.csgraph._reordering.__all__(B is not present at runtime scipy.sparse.csgraph._reordering.reverse_cuthill_mckee(B is inconsistent, stub does not have argument "graph" scipy.sparse.csgraph._reordering.reverse_cuthill_mckee(B is inconsistent, stub does not have argument "symmetric_mode" scipy.sparse.csgraph._reordering.reverse_cuthill_mckee(B is inconsistent, runtime does not have *args argument "args" @@ -1911,7 +1520,6 @@ scipy.sparse.csgraph._reordering.structural_rank(B is inconsistent, runtime does not have **kwargs argument "kwargs" scipy.sparse.csgraph._shortest_path.NegativeCycleError.__init__(B is inconsistent, stub does not have argument "message" scipy.sparse.csgraph._shortest_path.NegativeCycleError.__init__(B is inconsistent, runtime does not have *args argument "args" -scipy.sparse.csgraph._shortest_path.__test__(B is not present in stub scipy.sparse.csgraph._shortest_path.bellman_ford(B is inconsistent, stub does not have argument "csgraph" scipy.sparse.csgraph._shortest_path.bellman_ford(B is inconsistent, stub does not have argument "directed" scipy.sparse.csgraph._shortest_path.bellman_ford(B is inconsistent, stub does not have argument "indices" @@ -1960,7 +1568,6 @@ scipy.sparse.csgraph._shortest_path.yen(B is inconsistent, stub does not have argument "return_predecessors" scipy.sparse.csgraph._shortest_path.yen(B is inconsistent, stub does not have argument "unweighted" scipy.sparse.csgraph._shortest_path.yen(B is inconsistent, runtime does not have **kwargs argument "kwargs" -scipy.sparse.csgraph._tools.__all__(B is not present at runtime scipy.sparse.csgraph._tools.construct_dist_matrix(B is inconsistent, stub does not have argument "graph" scipy.sparse.csgraph._tools.construct_dist_matrix(B is inconsistent, stub does not have argument "predecessors" scipy.sparse.csgraph._tools.construct_dist_matrix(B is inconsistent, stub does not have argument "directed" @@ -1995,7 +1602,6 @@ scipy.sparse.csgraph._tools.reconstruct_path(B is inconsistent, stub does not have argument "directed" scipy.sparse.csgraph._tools.reconstruct_path(B is inconsistent, runtime does not have *args argument "args" scipy.sparse.csgraph._tools.reconstruct_path(B is inconsistent, runtime does not have **kwargs argument "kwargs" -scipy.sparse.csgraph._traversal.__all__(B is not present at runtime scipy.sparse.csgraph._traversal.breadth_first_order(B is inconsistent, stub does not have argument "csgraph" scipy.sparse.csgraph._traversal.breadth_first_order(B is inconsistent, stub does not have argument "i_start" scipy.sparse.csgraph._traversal.breadth_first_order(B is inconsistent, stub does not have argument "directed" @@ -2079,11 +1685,9 @@ scipy.sparse.linalg.spsolve(B is not present in stub scipy.sparse.linalg.spsolve_triangular(B is not present in stub scipy.sparse.linalg.use_solver(B is not present in stub -scipy.sparse.linalg._dsolve.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.sparse.linalg._dsolve.SuperLU(B cannot be subclassed at runtime, but isn't marked with @final in the stub scipy.sparse.linalg._dsolve.splu(B is inconsistent, runtime argument "options" has a default value of {}, which is different from stub argument default None scipy.sparse.linalg._dsolve._superlu.SuperLU(B cannot be subclassed at runtime, but isn't marked with @final in the stub -scipy.sparse.linalg._dsolve._superlu.__all__(B is not present at runtime scipy.sparse.linalg._dsolve._superlu.gssv(B is not present in stub scipy.sparse.linalg._dsolve._superlu.gstrf(B is not present in stub scipy.sparse.linalg._dsolve._superlu.gstrs(B is not present in stub @@ -2221,7 +1825,6 @@ scipy.spatial._spherical_voronoi.cKDTree.__reduce_cython__(B is not present in stub scipy.spatial._spherical_voronoi.cKDTree.__setstate_cython__(B is not present in stub scipy.spatial._spherical_voronoi.cKDTree.query_ball_tree(B is inconsistent, runtime argument "p" has a default value but stub argument does not -scipy.spatial.ckdtree.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.spatial.ckdtree.cKDTree.__init__(B is inconsistent, stub does not have *args argument "args" scipy.spatial.ckdtree.cKDTree.__reduce_cython__(B is not present in stub scipy.spatial.ckdtree.cKDTree.__setstate_cython__(B is not present in stub @@ -2229,7 +1832,6 @@ scipy.spatial.distance.jensenshannon(B is inconsistent, stub does not have argument "axis" scipy.spatial.distance.jensenshannon(B is inconsistent, stub does not have argument "keepdims" scipy.spatial.distance.kulczynski1(B is inconsistent, stub argument "w" is not keyword-only -scipy.spatial.kdtree.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.spatial.kdtree.KDTree.__init__(B is inconsistent, stub does not have argument "data" scipy.spatial.kdtree.KDTree.__init__(B is inconsistent, stub does not have argument "leafsize" scipy.spatial.kdtree.KDTree.__init__(B is inconsistent, stub does not have argument "compact_nodes" @@ -2241,7 +1843,6 @@ scipy.spatial.kdtree.cKDTree.__reduce_cython__(B is not present in stub scipy.spatial.kdtree.cKDTree.__setstate_cython__(B is not present in stub scipy.spatial.kdtree.cKDTree.query_ball_tree(B is inconsistent, runtime argument "p" has a default value but stub argument does not -scipy.spatial.qhull.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.spatial.qhull.Delaunay.find_simplex(B is inconsistent, runtime argument "tol" has a default value of type None, which is incompatible with stub argument type float scipy.spatial.transform.Rotation.__reduce_cython__(B is not present in stub scipy.spatial.transform.Rotation.__setstate_cython__(B is not present in stub @@ -2249,13 +1850,9 @@ scipy.spatial.transform._rotation.Rotation.__reduce_cython__(B is not present in stub scipy.spatial.transform._rotation.Rotation.__setstate_cython__(B is not present in stub scipy.spatial.transform._rotation.Rotation.approx_equal(B is inconsistent, runtime argument "atol" has a default value but stub argument does not -scipy.spatial.transform._rotation.__all__(B is not present at runtime -scipy.spatial.transform._rotation_spline.__all__(B is not present at runtime scipy.spatial.transform.rotation.Rotation.__reduce_cython__(B is not present in stub scipy.spatial.transform.rotation.Rotation.__setstate_cython__(B is not present in stub scipy.spatial.transform.rotation.Rotation.approx_equal(B is inconsistent, runtime argument "atol" has a default value but stub argument does not -scipy.spatial.transform.rotation.__all__(B variable differs from runtime type list[Untyped] -scipy.special.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.special.btdtr(B variable differs from runtime type def (*args: Untyped, **kwargs: Untyped) -> Untyped scipy.special.btdtri(B variable differs from runtime type def (*args: Untyped, **kwargs: Untyped) -> Untyped scipy.special.comb(B is inconsistent, stub argument "n" differs from runtime argument "N" @@ -2264,16 +1861,12 @@ scipy.special.factorialk(B is inconsistent, runtime argument "exact" is not keyword-only scipy.special.perm(B is inconsistent, stub argument "n" differs from runtime argument "N" scipy.special.perm(B is inconsistent, runtime argument "exact" is not keyword-only -scipy.special._add_newdocs.__all__(B is not present at runtime scipy.special._basic.comb(B is inconsistent, stub argument "n" differs from runtime argument "N" scipy.special._basic.factorial(B is inconsistent, runtime argument "exact" is not keyword-only scipy.special._basic.factorial2(B is inconsistent, runtime argument "exact" is not keyword-only scipy.special._basic.factorialk(B is inconsistent, runtime argument "exact" is not keyword-only scipy.special._basic.perm(B is inconsistent, stub argument "n" differs from runtime argument "N" scipy.special._basic.perm(B is inconsistent, runtime argument "exact" is not keyword-only -scipy.special._ellip_harm.__all__(B is not present at runtime -scipy.special._lambertw.__all__(B is not present at runtime -scipy.special._orthogonal.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.special._orthogonal.c_roots(B is not present in stub scipy.special._orthogonal.cg_roots(B is not present in stub scipy.special._orthogonal.h_roots(B is not present in stub @@ -2294,10 +1887,6 @@ scipy.special._orthogonal.ts_roots(B is not present in stub scipy.special._orthogonal.u_roots(B is not present in stub scipy.special._orthogonal.us_roots(B is not present in stub -scipy.special._sf_error.__all__(B is not present at runtime -scipy.special._spherical_bessel.__all__(B is not present at runtime -scipy.special.cython_special.__all__(B is not present at runtime -scipy.stats.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.stats.BootstrapMethod.__init__(B is inconsistent, runtime argument "batch" has a default value of type None, which is incompatible with stub argument type int scipy.stats.ConfidenceInterval(B is not present at runtime scipy.stats.ECDFResult(B is not present at runtime @@ -2453,7 +2042,6 @@ scipy.stats.mood(B is inconsistent, stub does not have argument "keepdims" scipy.stats.mood(B is inconsistent, stub does not have argument "nan_policy" scipy.stats.moyal(B is not present in stub -scipy.stats.mstats_extras(B is not present in stub scipy.stats.mvn(B is not present in stub scipy.stats.nakagami(B is not present in stub scipy.stats.nbinom(B is not present in stub @@ -2571,11 +2159,6 @@ scipy.stats._axis_nan_policy.too_small_1d_omit(B is not present in stub scipy.stats._axis_nan_policy.too_small_nd_not_omit(B is not present in stub scipy.stats._axis_nan_policy.too_small_nd_omit(B is not present in stub -scipy.stats._binomtest.__all__(B is not present at runtime -scipy.stats._bws_test.__all__(B is not present at runtime -scipy.stats._censored_data.__all__(B is not present at runtime -scipy.stats._common.__all__(B is not present at runtime -scipy.stats._continuous_distns.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.stats._continuous_distns.norm_gen.fit(B is inconsistent, runtime does not have *args argument "args" scipy.stats._continuous_distns.reciprocal_gen.fit_note(B is not present in stub scipy.stats._continuous_distns.rv_histogram.__init__(B is inconsistent, stub does not have argument "histogram" @@ -2591,14 +2174,12 @@ scipy.stats._continuous_distns.rv_histogram.__init__(B is inconsistent, runtime does not have argument "xtol" scipy.stats._continuous_distns.rv_histogram.__init__(B is inconsistent, stub does not have argument "density" scipy.stats._continuous_distns.rv_histogram.__init__(B is inconsistent, stub does not have **kwargs argument "kwargs" -scipy.stats._discrete_distns.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.stats._discrete_distns._nchypergeom_gen.dist(B is not present in stub scipy.stats._discrete_distns._nchypergeom_gen.rvs_name(B is not present in stub scipy.stats._discrete_distns.nchypergeom_fisher_gen.dist(B is not present in stub scipy.stats._discrete_distns.nchypergeom_fisher_gen.rvs_name(B is not present in stub scipy.stats._discrete_distns.nchypergeom_wallenius_gen.dist(B is not present in stub scipy.stats._discrete_distns.nchypergeom_wallenius_gen.rvs_name(B is not present in stub -scipy.stats._distn_infrastructure.__all__(B is not present at runtime scipy.stats._distn_infrastructure.docdict(B is not present in stub scipy.stats._distn_infrastructure.docdict_discrete(B is not present in stub scipy.stats._distn_infrastructure.docheaders(B is not present in stub @@ -2656,7 +2237,6 @@ scipy.stats._distn_infrastructure.rv_sample.qvals(B is not present at runtime scipy.stats._distn_infrastructure.rv_sample.vecentropy(B is not present at runtime scipy.stats._distn_infrastructure.rv_sample.xk(B is not present at runtime -scipy.stats._distr_params.__all__(B is not present at runtime scipy.stats._entropy.differential_entropy(B is inconsistent, stub does not have argument "keepdims" scipy.stats._entropy.differential_entropy(B is inconsistent, stub does not have argument "nan_policy" scipy.stats._entropy.entropy(B is inconsistent, stub does not have argument "keepdims" @@ -2832,7 +2412,6 @@ scipy.stats._survival.EmpiricalDistributionFunction.__match_args__(B variable differs from runtime type ('quantiles', 'probabilities', '_n', '_d', '_sf', '_kind') scipy.stats._warnings_errors.FitError.__init__(B is inconsistent, stub does not have argument "msg" scipy.stats._warnings_errors.FitError.__init__(B is inconsistent, runtime does not have *args argument "args" -scipy.stats.distributions.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.stats.distributions.entropy(B is inconsistent, stub does not have argument "keepdims" scipy.stats.distributions.entropy(B is inconsistent, stub does not have argument "nan_policy" scipy.stats.distributions.rv_continuous.__init__(B is inconsistent, runtime argument "momtype" is not keyword-only @@ -2914,19 +2493,8 @@ scipy.stats.mstats.t(B is not present at runtime scipy.stats.mstats.trim1(B is not present at runtime scipy.stats.mstats.trimdoc(B is not present at runtime -scipy.stats.mstats_extras.compare_medians_ms(B is not present in stub -scipy.stats.mstats_extras.hdmedian(B is not present in stub -scipy.stats.mstats_extras.hdquantiles(B is not present in stub -scipy.stats.mstats_extras.hdquantiles_sd(B is not present in stub -scipy.stats.mstats_extras.idealfourths(B is not present in stub -scipy.stats.mstats_extras.median_cihs(B is not present in stub -scipy.stats.mstats_extras.mjci(B is not present in stub -scipy.stats.mstats_extras.mquantiles_cimj(B is not present in stub -scipy.stats.mstats_extras.rsh(B is not present in stub -scipy.stats.mstats_extras.trimmed_mean_ci(B is not present in stub scipy.stats.qmc.PoissonDisk.__init__(B is inconsistent, runtime does not have argument "l_bounds" scipy.stats.qmc.PoissonDisk.__init__(B is inconsistent, runtime does not have argument "u_bounds" -scipy.stats.sampling.__all__(B names exported from the stub do not correspond to the names exported at runtime. This is probably due to things being missing from the stub or an inaccurate `__all__` in the stub scipy.stats.sampling.DiscreteAliasUrn(B is not present in stub scipy.stats.sampling.DiscreteGuideTable(B is not present in stub scipy.stats.sampling.NumericalInverseHermite(B is not present in stub @@ -2934,18 +2502,6 @@ scipy.stats.sampling.SimpleRatioUniforms(B is not present in stub scipy.stats.sampling.TransformedDensityRejection(B is not present in stub scipy.stats.sampling.UNURANError(B is not present in stub -scipy._lib.cobyqa.framework(B failed to find stubs -scipy._lib.cobyqa.main(B failed to find stubs -scipy._lib.cobyqa.models(B failed to find stubs -scipy._lib.cobyqa.problem(B failed to find stubs -scipy._lib.cobyqa.settings(B failed to find stubs -scipy._lib.cobyqa.subsolvers(B failed to find stubs -scipy._lib.cobyqa.subsolvers.geometry(B failed to find stubs -scipy._lib.cobyqa.subsolvers.optim(B failed to find stubs -scipy._lib.cobyqa.utils(B failed to find stubs -scipy._lib.cobyqa.utils.exceptions(B failed to find stubs -scipy._lib.cobyqa.utils.math(B failed to find stubs -scipy._lib.cobyqa.utils.versions(B failed to find stubs scipy.fftpack.convolve(B failed to find stubs scipy.linalg.cython_blas(B failed to find stubs scipy.linalg.cython_lapack(B failed to find stubs diff --git a/tests/stubtest/allowlist.txt b/tests/stubtest/allowlist.txt index 7c380024..8e9b7df1 100644 --- a/tests/stubtest/allowlist.txt +++ b/tests/stubtest/allowlist.txt @@ -72,7 +72,7 @@ scipy._lib.array_api_compat.dask.* scipy._lib.array_api_compat.numpy.* scipy._lib.array_api_compat.torch scipy._lib.array_api_compat.common._typing.* -scipy._lib.cobyqa +scipy._lib.cobyqa.* scipy._lib.messagestream scipy.fft._pocketfft.pypocketfft.* scipy.special.add_newdocs @@ -80,27 +80,99 @@ scipy.special.libsf_error_state scipy.special._precompute.* scipy.special._support_alternative_backends.* scipy.stats._rcont.rcont -scipy.stats._rcont.rcont scipy.stats._unuran.unuran_wrapper -# deprecated public api +# deprecated public api (will be removed in scipy 2.0.0) +scipy.constants.codata +scipy.constants.constants +scipy.integrate.lsoda.* +scipy.integrate.odepack.* +scipy.integrate.quadpack.* scipy.integrate.quadrature scipy.integrate.romberg scipy.integrate._quadrature.quadrature scipy.integrate._quadrature.romberg +scipy.linalg.basic.* +scipy.linalg.decomp.* +scipy.linalg.matfuncs.* +scipy.linalg.misc.* +scipy.linalg.special_matrices.* +scipy.optimize.cobyla.* +scipy.optimize.lbfgsb.* +scipy.optimize.linesearch.* +scipy.optimize.minpack.* +scipy.optimize.nonlin.* +scipy.optimize.optimize.* +scipy.optimize.slsqp.* +scipy.optimize.tnc.* +scipy.optimize.zeros.* scipy.special.basic scipy.special.orthogonal scipy.special.sf_error scipy.special.specfun scipy.special.spfun_stats scipy.linalg.basic -scipy.linalg.decomp* scipy.stats.kde.* scipy.stats.morestats.* scipy.stats.mstats_basic.* +scipy.stats.mstats_extras.* scipy.stats.stats.* # random mypy hallucinations scipy.interpolate.AAA scipy.interpolate._aaa scipy.interpolate._interpnd_info + +# mypy didn't read the typing specs on `__all__` within stubs +scipy._lib._ccallback.__all__ +scipy._lib.array_api_compat.__all__ +scipy._lib.array_api_compat.common.__all__ +scipy.integrate._ivp.__all__ +scipy.linalg._decomp_lu_cython.__all__ +scipy.linalg._solve_toeplitz.__all__ +scipy.optimize._constraints.__all__ +scipy.optimize._lsap.__all__ +scipy.optimize._remove_redundancy.__all__ +scipy.optimize._trlib._trlib.__all__ +scipy.signal._signaltools.__all__ +scipy.sparse._matrix.__all__ +scipy.sparse.csgraph.__all__ +scipy.sparse.csgraph._flow.__all__ +scipy.sparse.csgraph._laplacian.__all__ +scipy.sparse.csgraph._matching.__all__ +scipy.sparse.csgraph._min_spanning_tree.__all__ +scipy.sparse.csgraph._reordering.__all__ +scipy.sparse.csgraph._shortest_path.__all__ +scipy.sparse.csgraph._tools.__all__ +scipy.sparse.csgraph._traversal.__all__ +scipy.sparse.linalg._dsolve._superlu.__all__ +scipy.spatial.transform._rotation.__all__ +scipy.spatial.transform._rotation_spline.__all__ +scipy.special._add_newdocs.__all__ +scipy.special._ellip_harm.__all__ +scipy.special._lambertw.__all__ +scipy.special._orthogonal.__all__ +scipy.special._sf_error.__all__ +scipy.special._spherical_bessel.__all__ +scipy.special.cython_special.__all__ +scipy.stats._binomtest.__all__ +scipy.stats._bws_test.__all__ +scipy.stats._censored_data.__all__ +scipy.stats._common.__all__ +scipy.stats._distn_infrastructure.__all__ +scipy.stats._distr_params.__all__ + +# mypy doesn't know how to sort `__all__` +scipy.constants.__all__ +scipy.integrate.__all__ +scipy.linalg.__all__ +scipy.sparse.linalg._dsolve.__all__ +scipy.spatial.ckdtree.__all__ +scipy.spatial.kdtree.__all__ +scipy.spatial.qhull.__all__ +scipy.special.__all__ +scipy.stats.__all__ +scipy.stats._continuous_distns.__all__ +scipy.stats._discrete_distns.__all__ +scipy.stats.distributions.__all__ +scipy.stats.sampling.__all__