Ecosyste.ms: OpenCollective
An open API service for software projects hosted on Open Collective.
SciPy
SciPy (pronounced “Sigh Pie”) is a Python-based ecosystem of open-source software for mathematics, science, and engineering.
Collective -
Host: numfocus -
https://opencollective.com/scipy
- Website: https://scipy.org/
- Code: https://github.com/scipy
Update _differentialevolution.py
github.com/scipy/scipy - Sinamahani opened this pull request 8 months ago
github.com/scipy/scipy - Sinamahani opened this pull request 8 months ago
BUG: ndimage.binary_erosion: avoid divide by zero by capping block_size at size
github.com/scipy/scipy - nickodell opened this pull request 8 months ago
github.com/scipy/scipy - nickodell opened this pull request 8 months ago
ENH:sparse.linalg: Update vendored ARPACK version to 3.9.1
github.com/scipy/scipy - ilayn opened this pull request 8 months ago
github.com/scipy/scipy - ilayn opened this pull request 8 months ago
MAINT: `stats.combine_pvalues`: fix native `axis` support for `method='stouffer'`
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
BUG: sparse: fix 1D for vstack/hstack and Improve 1D error msgs in h/v-stacks/kron/kronsum
github.com/scipy/scipy - dschult opened this pull request 8 months ago
github.com/scipy/scipy - dschult opened this pull request 8 months ago
DOC: add release note for 1.14 sparse section about sparse array iteration
github.com/scipy/scipy - dschult opened this pull request 8 months ago
github.com/scipy/scipy - dschult opened this pull request 8 months ago
BUG: `stats.combine_pvalues` gives result with wrong dimensionality (regression from v1.14.0)
github.com/scipy/scipy - michaelpradel opened this issue 8 months ago
github.com/scipy/scipy - michaelpradel opened this issue 8 months ago
Modifying `_ravel_coords` function used in `reshape` method for 3d `coo_array` objects
github.com/scipy/scipy - anushkasuyal opened this issue 8 months ago
github.com/scipy/scipy - anushkasuyal opened this issue 8 months ago
MAINT: Unskip `scipy.misc.test.test_decorator` for Python 3.13+
github.com/scipy/scipy - czgdp1807 opened this pull request 8 months ago
github.com/scipy/scipy - czgdp1807 opened this pull request 8 months ago
MAINT: itemsize pybind cleanup
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
RFC/ENH?: `optimize.curve_fit`: option to use global optimization for curve fit
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
DOC: special.ellipj: fix order of parameters in docstring
github.com/scipy/scipy - j-bowhay opened this pull request 8 months ago
github.com/scipy/scipy - j-bowhay opened this pull request 8 months ago
Error when I try to install Scipy version 1.10.0 on a python:3.9.11-alpine docker image
github.com/scipy/scipy - MarcusPaiva opened this issue 8 months ago
github.com/scipy/scipy - MarcusPaiva opened this issue 8 months ago
DOC: incorrect section ordering for classes
github.com/scipy/scipy - lucascolley opened this issue 8 months ago
github.com/scipy/scipy - lucascolley opened this issue 8 months ago
DEV: don't add `sparse` label for submodules
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
ENH: `stats.boxcox_llf`: add array API support
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
DOC: sparse.linalg.gcrotmk: add missing backticks
github.com/scipy/scipy - anushkasuyal opened this pull request 8 months ago
github.com/scipy/scipy - anushkasuyal opened this pull request 8 months ago
DOC: `RegularGridInterpolator` uses half down rounding instead of half up
github.com/scipy/scipy - waltsims opened this issue 8 months ago
github.com/scipy/scipy - waltsims opened this issue 8 months ago
DOC: sparse.linalg.gcrotmk: fix backticks and add `maxiter` default
github.com/scipy/scipy - anushkasuyal opened this pull request 8 months ago
github.com/scipy/scipy - anushkasuyal opened this pull request 8 months ago
DOC: sparse.linalg.gcrotmk : Typeset code objects in docstring
github.com/scipy/scipy - anushkasuyal opened this pull request 8 months ago
github.com/scipy/scipy - anushkasuyal opened this pull request 8 months ago
BUG: minimize: fix for powell method
github.com/scipy/scipy - irideselby opened this pull request 8 months ago
github.com/scipy/scipy - irideselby opened this pull request 8 months ago
RFC/MAINT: spatial.distance: consolidate Cython and Python metric implementations
github.com/scipy/scipy - fancidev opened this issue 8 months ago
github.com/scipy/scipy - fancidev opened this issue 8 months ago
ENH: `stats.alexandergovern`: vectorize calculation for n-D arrays
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
DOC: `optimize.InverseJacobian`: document or deprecate?
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
DOC: optimize: remove inadvertent block quote indentation
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
DOC: spatial: Fix typo in `seuclidean` docstring
github.com/scipy/scipy - kwinkunks opened this pull request 8 months ago
github.com/scipy/scipy - kwinkunks opened this pull request 8 months ago
DEP: spatial: deprecate complex input to `cosine` and `correlation`
github.com/scipy/scipy - fancidev opened this pull request 8 months ago
github.com/scipy/scipy - fancidev opened this pull request 8 months ago
BLD: Enable `open_memstream()` on newer glibc
github.com/scipy/scipy - nickodell opened this pull request 8 months ago
github.com/scipy/scipy - nickodell opened this pull request 8 months ago
MAINT: simplify `_integrate_pdf`
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
TST: experiment to determine what warnings pytest reports
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
DOC: Add default options for COBYQA
github.com/scipy/scipy - ragonneau opened this pull request 8 months ago
github.com/scipy/scipy - ragonneau opened this pull request 8 months ago
BUG: Problems with developer installation in Debian virtualenv
github.com/scipy/scipy - MikhailRyazanov opened this issue 8 months ago
github.com/scipy/scipy - MikhailRyazanov opened this issue 8 months ago
BUG: unable to securely deploy app as scipy 1.14.0 requires write permission in docker container.
github.com/scipy/scipy - Cemlyn opened this issue 8 months ago
github.com/scipy/scipy - Cemlyn opened this issue 8 months ago
BUG: linalg.expm: slower by a factor of ~4 in `scipy>1.13`
github.com/scipy/scipy - domna opened this issue 8 months ago
github.com/scipy/scipy - domna opened this issue 8 months ago
ENH/DEP: `stats.find_repeats/tiecorrect/etc.`: add array API support or deprecate?
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
ENH: `stats.differential_entropy`: add array API support
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
BUG/DEV: `PytestUnknownMarkWarning` from `-t`
github.com/scipy/scipy - lucascolley opened this issue 8 months ago
github.com/scipy/scipy - lucascolley opened this issue 8 months ago
MAINT: adapt to array-api-strict 2.0
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
MAINT: `cluster`/`stats`: array API test failures in main
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
github.com/scipy/scipy - mdhaber opened this issue 8 months ago
BUG: interpolate: `RecursionError` when importing `BSpline`
github.com/scipy/scipy - BartSchuurmans opened this issue 8 months ago
github.com/scipy/scipy - BartSchuurmans opened this issue 8 months ago
DOC: doctest failures in private functions
github.com/scipy/scipy - e-kwsm opened this issue 8 months ago
github.com/scipy/scipy - e-kwsm opened this issue 8 months ago
BUG: 'simps' not found from 'scipy.integrate'
github.com/scipy/scipy - gusmihaian opened this issue 8 months ago
github.com/scipy/scipy - gusmihaian opened this issue 8 months ago
MAINT: uarray: fix typo in `small_dynamic_array.h`
github.com/scipy/scipy - h-vetinari opened this pull request 8 months ago
github.com/scipy/scipy - h-vetinari opened this pull request 8 months ago
ENH: `stats.zmap`/`zscore`/`gzscore`: add array API support
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
BUG: special: remove type punning to avoid warnings in LTO builds
github.com/scipy/scipy - steppi opened this pull request 8 months ago
github.com/scipy/scipy - steppi opened this pull request 8 months ago
ENH: Updated signal.lombscargle to the generalized Lomb-Scargle periodogram
github.com/scipy/scipy - adammj opened this pull request 8 months ago
github.com/scipy/scipy - adammj opened this pull request 8 months ago
BUG: After updating to numpy 2.0.0, scipy fails to build with LTO errors.
github.com/scipy/scipy - eli-schwartz opened this issue 8 months ago
github.com/scipy/scipy - eli-schwartz opened this issue 8 months ago
BUG: sparse: `hstack/vstack` between a sparse and ndarray breaks in >=1.13.0
github.com/scipy/scipy - jkanche opened this issue 8 months ago
github.com/scipy/scipy - jkanche opened this issue 8 months ago
MAINT: gcc-14 test_region5 tol bump
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
BUG: special: Fixes for pro_rad1
github.com/scipy/scipy - steppi opened this pull request 8 months ago
github.com/scipy/scipy - steppi opened this pull request 8 months ago
Add information about current best point in callback of `optimize.minimize`
github.com/scipy/scipy - schmoelder opened this issue 8 months ago
github.com/scipy/scipy - schmoelder opened this issue 8 months ago
ENH: RBFInterpolator classmethods for loading RBFInterpolator
github.com/scipy/scipy - CorneSuijkerbuijk opened this issue 8 months ago
github.com/scipy/scipy - CorneSuijkerbuijk opened this issue 8 months ago
TST, MAINT: TestHyp2f1.test_region5 tol issue with gcc 14.1.0
github.com/scipy/scipy - tylerjereddy opened this issue 8 months ago
github.com/scipy/scipy - tylerjereddy opened this issue 8 months ago
BUG: `special.pro_rad1`: incorrect results
github.com/scipy/scipy - bmonreal opened this issue 8 months ago
github.com/scipy/scipy - bmonreal opened this issue 8 months ago
BUG: loong64 architecture fails TestQuad.test_complex
github.com/scipy/scipy - drew-parsons opened this issue 8 months ago
github.com/scipy/scipy - drew-parsons opened this issue 8 months ago
free-threaded x86-64 macOS wheel build job failed with pybind11 2.13.0
github.com/scipy/scipy - rgommers opened this issue 8 months ago
github.com/scipy/scipy - rgommers opened this issue 8 months ago
ENH: stats.obrientransform: add array API support
github.com/scipy/scipy - j-bowhay opened this pull request 8 months ago
github.com/scipy/scipy - j-bowhay opened this pull request 8 months ago
Query: upstreaming `_lib._array_api` discussion
github.com/scipy/scipy - KelSolaar opened this issue 8 months ago
github.com/scipy/scipy - KelSolaar opened this issue 8 months ago
ENH: Why HiGHs/milp needs more and more memory space when runtime goes by.
github.com/scipy/scipy - SomaLily opened this issue 8 months ago
github.com/scipy/scipy - SomaLily opened this issue 8 months ago
BUG: `eval_hermite` is incompatible with NumPy 2.0 on Windows
github.com/scipy/scipy - njzjz opened this issue 8 months ago
github.com/scipy/scipy - njzjz opened this issue 8 months ago
BUG: interpolate.LinearNDInterpolator: fix for precomputed triangulation
github.com/scipy/scipy - Djip007 opened this pull request 8 months ago
github.com/scipy/scipy - Djip007 opened this pull request 8 months ago
ENH: `stats.Normal`: add new continuous distribution infrastructure + normal distribution
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
BUG: csr_matrix.A not implemented
github.com/scipy/scipy - JunyanReplicant opened this issue 8 months ago
github.com/scipy/scipy - JunyanReplicant opened this issue 8 months ago
BUG: Testsuite fails to start with GCC 14
github.com/scipy/scipy - glaubitz opened this issue 8 months ago
github.com/scipy/scipy - glaubitz opened this issue 8 months ago
TST: optimize: fix exception test on PyPy3.10
github.com/scipy/scipy - mgorny opened this pull request 8 months ago
github.com/scipy/scipy - mgorny opened this pull request 8 months ago
RFC/DEP: decorator to deprecate positional/keyword uses of arguments?
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
BUG: `scipy/optimize/tests/test_hessian_update_strategy.py::TestHessianUpdateStrategy::test_initialize_catch_illegal` fails on PyPy3
github.com/scipy/scipy - mgorny opened this issue 8 months ago
github.com/scipy/scipy - mgorny opened this issue 8 months ago
RFC: quo vadis, `xp_assert_*` infrastructure?
github.com/scipy/scipy - h-vetinari opened this issue 8 months ago
github.com/scipy/scipy - h-vetinari opened this issue 8 months ago
BUG: scipy.interpolate.LinearNDInterpolator call _calculate_triangulation with Delaunay triangulation
github.com/scipy/scipy - Djip007 opened this issue 8 months ago
github.com/scipy/scipy - Djip007 opened this issue 8 months ago
DOC: stats: Move biomedical examples to notebooks
github.com/scipy/scipy - melissawm opened this pull request 8 months ago
github.com/scipy/scipy - melissawm opened this pull request 8 months ago
ENH: `differentiate`: add sub-package for array-API compatible numerical differentiation tools
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
BLD: in VS code Docker Dev container No such file or directory: '/tmp/pip-build-env-na93e837/overlay/bin/pybind11-config'
github.com/scipy/scipy - lobpcg opened this issue 8 months ago
github.com/scipy/scipy - lobpcg opened this issue 8 months ago
ENH: Implement all relevant methods for `sparse.dia_array`
github.com/scipy/scipy - MikhailRyazanov opened this issue 8 months ago
github.com/scipy/scipy - MikhailRyazanov opened this issue 8 months ago
REL, MAINT: prep for 1.14.1
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
MAINT: forward port 1.14.0 relnotes
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
Add SciPy 1.14.0
github.com/scipy/docs.scipy.org - tylerjereddy opened this pull request 8 months ago
github.com/scipy/docs.scipy.org - tylerjereddy opened this pull request 8 months ago
Announce SciPy 1.14.0
github.com/scipy/scipy.org - tylerjereddy opened this pull request 8 months ago
github.com/scipy/scipy.org - tylerjereddy opened this pull request 8 months ago
ENH: stats.tvar/tstd/tsem: add array API support
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
ENH: stats.hmean/pmean: add array API support
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
ENH: stats.xp_var: array-API compatible variance with scipy.stats interface
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
DOC: interpolate: discuss linear interpolation with extrapolation
github.com/scipy/scipy - ev-br opened this pull request 8 months ago
github.com/scipy/scipy - ev-br opened this pull request 8 months ago
DOC/DEV: update vendored-code page
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
RFC: require alternative backends to pass SciPy's tests when "dispatching"?
github.com/scipy/scipy - lucascolley opened this issue 8 months ago
github.com/scipy/scipy - lucascolley opened this issue 8 months ago
DOC, DEV: release notes `gh_lists` touchups
github.com/scipy/scipy - tylerjereddy opened this issue 8 months ago
github.com/scipy/scipy - tylerjereddy opened this issue 8 months ago
MAINT/STY: Fix UP031 AND UP032 linter errors
github.com/scipy/scipy - adityakarumanchi opened this pull request 8 months ago
github.com/scipy/scipy - adityakarumanchi opened this pull request 8 months ago
ENH: stats.tmin/tmax: add array API support
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
github.com/scipy/scipy - mdhaber opened this pull request 8 months ago
BUG: linalg.lstsq produces illegal instruction
github.com/scipy/scipy - mbaudin47 opened this issue 8 months ago
github.com/scipy/scipy - mbaudin47 opened this issue 8 months ago
DOC: discuss pytest assertion rewrites in README
github.com/scipy/scipy_doctest - ev-br opened this pull request 8 months ago
github.com/scipy/scipy_doctest - ev-br opened this pull request 8 months ago
MAINT: change `xp_assert_*` functions from `allow_0d=False` to `check_0d=True`
github.com/scipy/scipy - h-vetinari opened this pull request 8 months ago
github.com/scipy/scipy - h-vetinari opened this pull request 8 months ago
API: signal: rename `sosfreqz` to `freqz_sos`
github.com/scipy/scipy - luxedo opened this pull request 8 months ago
github.com/scipy/scipy - luxedo opened this pull request 8 months ago
WIP: request assert_rewrite of scipy_doctest itself
github.com/scipy/scipy_doctest - ev-br opened this pull request 8 months ago
github.com/scipy/scipy_doctest - ev-br opened this pull request 8 months ago
BUG: pytest register_assert_rewrites of internal modules
github.com/scipy/scipy_doctest - ev-br opened this pull request 8 months ago
github.com/scipy/scipy_doctest - ev-br opened this pull request 8 months ago
DEV: lint: enforce newlines at end of files
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
github.com/scipy/scipy - lucascolley opened this pull request 8 months ago
BUG: sparse: Fix advanced indexing using both slice and array
github.com/scipy/scipy - dschult opened this pull request 8 months ago
github.com/scipy/scipy - dschult opened this pull request 8 months ago
ENH:MAINT:optimize: Re-rewrite nnls in Cython
github.com/scipy/scipy - ilayn opened this pull request 8 months ago
github.com/scipy/scipy - ilayn opened this pull request 8 months ago
DOC: signal: Use `where='post'` when plotting discrete response
github.com/scipy/scipy - patenteng opened this issue 8 months ago
github.com/scipy/scipy - patenteng opened this issue 8 months ago
MAINT: "final" backports for 1.14.0
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago
github.com/scipy/scipy - tylerjereddy opened this pull request 8 months ago