Revisions of python-scipy

buildservice-autocommit accepted request 1225155 from Dirk Mueller's avatar Dirk Mueller (dirkmueller) (revision 117)
baserev update by copy to link target
Dirk Mueller's avatar Dirk Mueller (dirkmueller) committed (revision 116)
- relax pythran requirement
  * BUG: stats.zipf: incorrect pmf values
  * Several scipy.sparse array API improvements, including sparse.sparray,
    a new public base class distinct from the older sparse.spmatrix class,
    proper 64-bit index support, and numerous deprecations paving the way
  * scipy.stats added tools for survival analysis, multiple hypothesis
  * A new function was added for quasi-Monte Carlo integration, and linear
  * An axes argument was added broadly to ndimage functions, facilitating
- Test in parallel (pytest-xdist)
    python -Wd and check for `DeprecationWarning`s).
    All convolution-based filters also now accept complex-valued inputs
    * `scipy.spatial.SphericalVoronoi` now supports n-dimensional input,
      * `scipy.fft` is a new submodule that supersedes the `scipy.fftpack` submodule.
        or the most part, this is a drop-in replacement for ``numpy.fft`` and
      * uses NumPy's conventions for real transforms (``rfft``). This means the
        his is different from the output of ``fftpack`` which returned a real array
      * the inverse real to real transforms (``idct`` and ``idst``) are normalized
        or ``norm=None`` in thesame way as ``ifft``. This means the identity
      * This submodule is based on the ``pypocketfft`` library, developed by the
      * Note that `scipy.fftpack` has not been deprecated and will continue to be
        aintained but is now considered legacy. New code is recommended to use
      * `scipy.integrate.solve_ivp` can now return a ``y_events`` attribute
        unge-Kutta method originally implemented in Fortran. Now we provide a pure
      * `scipy.integrate.quad` provides better user feedback when break points are
      * New boolean keyword argument ``check_finite`` for `scipy.linalg.norm`; whether
        o check that the input matrix contains only finite numbers. Disabling may
      * It is now possible to use linear and non-linear constraints with
      * `scipy.optimize.linear_sum_assignment` has been re-written in C++ to improve
      * The implementation of ``choose_conv_method`` has been updated to reflect the
        ew FFT implementation. In addition, the performance has been significantly
buildservice-autocommit accepted request 1199463 from Dirk Mueller's avatar Dirk Mueller (dirkmueller) (revision 115)
baserev update by copy to link target
Dirk Mueller's avatar Dirk Mueller (dirkmueller) accepted request 1199369 from Benjamin Greiner's avatar Benjamin Greiner (bnavigator) (revision 114)
- Add scipy-pybind11-2.13.patch gh#scipy/scipy#21199
- Rename 21063.patch to scipy-pr21063-gcc14.patch
Dirk Mueller's avatar Dirk Mueller (dirkmueller) accepted request 1198039 from Benjamin Greiner's avatar Benjamin Greiner (bnavigator) (revision 113)
- Update to SciPy 1.14.1
  * Add support for Python 3.13
  * Bug-fix release with no new features compared to 1.14.0.
buildservice-autocommit accepted request 1187907 from Markéta Machová's avatar Markéta Machová (mcalabkova) (revision 112)
baserev update by copy to link target
Markéta Machová's avatar Markéta Machová (mcalabkova) accepted request 1186930 from Benjamin Greiner's avatar Benjamin Greiner (bnavigator) (revision 111)
- Fix hpc build: Provide f2py with correct shebang for build-time
buildservice-autocommit accepted request 1184871 from Markéta Machová's avatar Markéta Machová (mcalabkova) (revision 110)
baserev update by copy to link target
Markéta Machová's avatar Markéta Machová (mcalabkova) accepted request 1184327 from John Paul Adrian Glaubitz's avatar John Paul Adrian Glaubitz (glaubitz) (revision 109)
- Update to 1.14.0
  ## Highlights of this release
  * SciPy now supports the new Accelerate library introduced in macOS 13.3, and
    has wheels built against Accelerate for macOS >=14 resulting in significant
    performance improvements for many linear algebra operations.
  * A new method, ``cobyqa``, has been added to `scipy.optimize.minimize` - this
    is an interface for COBYQA (Constrained Optimization BY Quadratic
    Approximations), a derivative-free optimization solver, designed to
    supersede COBYLA, developed by the Department of Applied Mathematics, The
    Hong Kong Polytechnic University.
  * `scipy.sparse.linalg.spsolve_triangular` is now more than an order of
    magnitude faster in many cases.
  ## New features
  # `scipy.fft` improvements
  * A new function, `scipy.fft.prev_fast_len`, has been added. This function
    finds the largest composite of FFT radices that is less than the target
    length. It is useful for discarding a minimal number of samples before FFT.
  #`scipy.io` improvements
  * ``wavfile`` now supports reading and writing of ``wav`` files in the RF64
    format, allowing files greater than 4 GB in size to be handled.
  #`scipy.constants` improvements
  * Experimental support for the array API standard has been added.
  #`scipy.interpolate` improvements
  * `scipy.interpolate.Akima1DInterpolator` now supports extrapolation via the
    ``extrapolate`` argument.
  #`scipy.optimize` improvements
  * `scipy.optimize.HessianUpdateStrategy` now also accepts square arrays for
    ``init_scale``.
  * A new method, ``cobyqa``, has been added to `scipy.optimize.minimize` - this
    is an interface for COBYQA (Constrained Optimization BY Quadratic
buildservice-autocommit accepted request 1177341 from Markéta Machová's avatar Markéta Machová (mcalabkova) (revision 108)
baserev update by copy to link target
Markéta Machová's avatar Markéta Machová (mcalabkova) accepted request 1177053 from Benjamin Greiner's avatar Benjamin Greiner (bnavigator) (revision 107)
- Update to 1.13.1
  * SciPy 1.13.1 is a bug-fix release with no new features compared
    to 1.13.0.
  ## Issues closed
  * BUG: `scipy.ndimage.value_indices` returns empty dict for
    `intc`/`uintc` dtype on Windows
  * BUG: csr_array can no longer be initialized with 1D array
  * BUG: `TestEig.test_falker` fails on windows + MKL as well as…
  * BUG: Cannot find `OpenBLAS` on Cygwin
  * BUG: special.spherical_in: derivative at `z=0, n=1` incorrect
  * BUG: `eigh` fails for size 1 array with driver=evd
  * BUG: warning from `optimize.least_squares` for astropy with…
  * BUG: spatial: error in `Rotation.align_vectors()` with an
    infinite…
  * BUG: scipy.special.factorial2 doesn’t handle `uint32` dtypes
  * BUG: scipy.stats.wilcoxon in 1.13 fails on 2D array with nan…
  * BUG: scipy.spatial.Delaunay,
    scipy.interpolate.LinearNDInterpolator…
  * BUG: stats.yulesimon: incorrect kurtosis values
  * BUG: incorrect origin tuple handling in ndimage
    `minimum_filter`…
  * BUG: spatial: `Rotation.align_vectors()` incorrect for
    anti-parallel…
  * BUG: sparse matrix creation in 1.13 with indices not summing…
  * BUG: stats.zipf: incorrect pmf values 
- Allow pythran 0.16: Upstream's pre-emptive pin is not necessary
- Drop scipy-pr20530-f2py_error.patch
buildservice-autocommit accepted request 1173658 from Dirk Mueller's avatar Dirk Mueller (dirkmueller) (revision 106)
baserev update by copy to link target
Dirk Mueller's avatar Dirk Mueller (dirkmueller) accepted request 1173499 from Sarah Kriesch's avatar Sarah Kriesch (AdaLovelace) (revision 105)
- Enable python-scipy:gnu-hpc for s390x (together with python-numpy:gnu-hpc)
buildservice-autocommit accepted request 1173051 from Markéta Machová's avatar Markéta Machová (mcalabkova) (revision 104)
baserev update by copy to link target
Markéta Machová's avatar Markéta Machová (mcalabkova) accepted request 1172886 from Sarah Kriesch's avatar Sarah Kriesch (AdaLovelace) (revision 103)
- Enable openblas for s390x
buildservice-autocommit accepted request 1170765 from Dirk Mueller's avatar Dirk Mueller (dirkmueller) (revision 102)
baserev update by copy to link target
Dirk Mueller's avatar Dirk Mueller (dirkmueller) accepted request 1170301 from Benjamin Greiner's avatar Benjamin Greiner (bnavigator) (revision 101)
- Skip another test out of numeric precision for 32-bit
- Fix HPC _version
Dirk Mueller's avatar Dirk Mueller (dirkmueller) accepted request 1169336 from Benjamin Greiner's avatar Benjamin Greiner (bnavigator) (revision 100)
- Update to 1.13.0
  ## Highlights of this release
  * Support for NumPy 2.0.0.
  * Interactive examples have been added to the documentation,
    allowing users to run the examples locally on embedded
    Jupyterlite notebooks in their browser.
  * Preliminary 1D array support for the COO and DOK sparse
    formats.
  * Several scipy.stats functions have gained support for
    additional axis, nan_policy, and keepdims arguments.
    scipy.stats also has several performance and accuracy
    improvements.
  ## New features
  * scipy.integrate improvements
  * scipy.io improvements
  * scipy.interpolate improvements
  * scipy.signal improvements
  * scipy.sparse improvements
  * scipy.spatial improvements
  * scipy.special improvements
  * scipy.stats improvements
  ## Deprecated features
  * Complex dtypes in PchipInterpolator and Akima1DInterpolator
    have been deprecated and will raise an error in SciPy 1.15.0.
    If you are trying to use the real components of the passed
    array, use np.real on y.
  ## Other changes
  * The second argument of scipy.stats.moment has been renamed to
    order while maintaining backward compatibility.
- Release 1.12.0
  ## Highlights of this release
  * Experimental support for the array API standard has been added
    to part of scipy.special, and to all of scipy.fft and
    scipy.cluster. There are likely to be bugs and early feedback
    for usage with CuPy arrays, PyTorch tensors, and other array
    API compatible libraries is appreciated. Use the
    SCIPY_ARRAY_API environment variable for testing.
  * A new class, ShortTimeFFT, provides a more versatile
    implementation of the short-time Fourier transform (STFT), its
    inverse (ISTFT) as well as the (cross-) spectrogram. It
    utilizes an improved algorithm for calculating the ISTFT.
  * Several new constructors have been added for sparse arrays, and
    many operations now additionally support sparse arrays, further
    facilitating the migration from sparse matrices.
  * A large portion of the scipy.stats API now has improved support
    for handling NaN values, masked arrays, and more fine-grained
    shape-handling. The accuracy and performance of a number of
    stats methods have been improved, and a number of new
    statistical tests and distributions have been added.
  ## New features
  * scipy.cluster improvements
  * scipy.fft improvements
  * scipy.integrate improvements
  * scipy.interpolate improvements
  * scipy.linalg improvements
  * scipy.ndimage improvements
  * scipy.optimize improvements
  * scipy.signal improvements
  * scipy.sparse improvements
  * scipy.spatial improvements
  * scipy.special improvements
  * scipy.stats improvements
  ## Deprecated features
  * Error messages have been made clearer for objects that don’t
    exist in the public namespace and warnings sharpened for
    private attributes that are not supposed to be imported at all.
  * scipy.signal.cmplx_sort has been deprecated and will be removed
    in SciPy 1.15. A replacement you can use is provided in the
    deprecation message.
  * Values the argument initial of
    scipy.integrate.cumulative_trapezoid other than 0 and None are
    now deprecated.
  * scipy.stats.rvs_ratio_uniforms is deprecated in favour of
    scipy.stats.sampling.RatioUniforms
  * scipy.integrate.quadrature and scipy.integrate.romberg have
    been deprecated due to accuracy issues and interface
    shortcomings. They will be removed in SciPy 1.15. Please use
    scipy.integrate.quad instead.
  * Coinciding with upcoming changes to function signatures (e.g.
    removal of a deprecated keyword), we are deprecating positional
    use of keyword arguments for the affected functions, which will
    raise an error starting with SciPy 1.14. In some cases, this
    has delayed the originally announced removal date, to give time
    to respond to the second part of the deprecation. Affected
    functions are:
    - linalg.{eigh, eigvalsh, pinv}
    - integrate.simpson
    - signal.{firls, firwin, firwin2, remez}
    - sparse.linalg.{bicg, bicgstab, cg, cgs, gcrotmk, gmres,
      lgmres, minres, qmr, tfqmr}
    - special.comb
    - stats.kendalltau
  * All wavelet functions have been deprecated, as PyWavelets
    provides suitable implementations; affected functions are:
    signal.{daub, qmf, cascade, morlet, morlet2, ricker, cwt}
  * scipy.integrate.trapz, scipy.integrate.cumtrapz, and
    scipy.integrate.simps have been deprecated in favour of
    scipy.integrate.trapezoid,
    scipy.integrate.cumulative_trapezoid, and
    scipy.integrate.simpson respectively and will be removed in
    SciPy 1.14.
  * The tol argument of
    scipy.sparse.linalg.{bcg,bicstab,cg,cgs,gcrotmk,gmres,lgmres,
    minres,qmr,tfqmr}
    is now deprecated in favour of rtol and will be removed in
    SciPy 1.14. Furthermore, the default value of atol for these
    functions is due to change to 0.0 in SciPy 1.14.
  ## Expired Deprecations
  * There is an ongoing effort to follow through on long-standing
    deprecations. The following previously deprecated features are
    affected:
  * The centered keyword of scipy.stats.qmc.LatinHypercube has been
    removed. Use scrambled=False instead of centered=True.
  * scipy.stats.binom_test has been removed in favour of
    scipy.stats.binomtest.
  * In scipy.stats.iqr, the use of scale='raw' has been removed in
    favour of scale=1.
  * Functions from NumPy’s main namespace which were exposed in
    SciPy’s main namespace, such as numpy.histogram exposed by
    scipy.histogram, have been removed from SciPy’s main namespace.
    Please use the functions directly from numpy.
  ## Other changes
  * The arguments used to compile and link SciPy are now available
    via show_config.
- Drop 8c96a1f742335bca283aae418763aaba62c03378.patch (merged
  upstream)
- Add scipy-pr20530-f2py_error.patch gh#scipy/scipy#20530, used to
  find workaround for failing HPC build gh#scipy/scipy#20535
buildservice-autocommit accepted request 1153127 from Matej Cepl's avatar Matej Cepl (mcepl) (revision 99)
baserev update by copy to link target
Matej Cepl's avatar Matej Cepl (mcepl) accepted request 1152470 from Egbert Eich's avatar Egbert Eich (eeich) (revision 98)
- Add 8c96a1f742335bca283aae418763aaba62c03378.patch
  to fix issues with OpenBLAS 0.3.26 and later (boo#1220163).

  This fix is required to update OpenBLAS in oS:Factory!
Displaying revisions 1 - 20 of 117
openSUSE Build Service is sponsored by