Index | index by Group | index by Distribution | index by Vendor | index by creation date | index by Name | Mirrors | Help | Search |
Name: python311-scipy-gnu-hpc | Distribution: openSUSE Tumbleweed |
Version: 1.14.1 | Vendor: openSUSE |
Release: 2.3 | Build date: Tue Nov 19 20:07:38 2024 |
Group: Productivity/Scientific/Other | Build host: reproducible |
Size: 205 | Source RPM: python-scipy_1_13_1-gnu-hpc-1.14.1-2.3.src.rpm |
Packager: https://bugs.opensuse.org | |
Url: https://www.scipy.org | |
Summary: Dependency package for python311-scipy_1_13_1-gnu-hpc |
python311-scipy: Scientific Tools for Python The package python311-scipy-gnu-hpc provides the dependency to get binary package python311-scipy_1_13_1-gnu-hpc. When this package gets updated it installs the latest version of python311-scipy_1_13_1-gnu-hpc.
BSD-3-Clause AND LGPL-2.0-or-later AND BSL-1.0
* Tue Nov 19 2024 Dirk Müller <dmueller@suse.com> - relax pythran requirement * Fri Sep 06 2024 Ben Greiner <code@bnavigator.de> - Add scipy-pybind11-2.13.patch gh#scipy/scipy#21199 - Rename 21063.patch to scipy-pr21063-gcc14.patch * Sat Aug 31 2024 Ben Greiner <code@bnavigator.de> - Update to SciPy 1.14.1 * Add support for Python 3.13 * Bug-fix release with no new features compared to 1.14.0. * Thu Jul 11 2024 Ben Greiner <code@bnavigator.de> - Fix hpc build: Provide f2py with correct shebang for build-time * Mon Jul 01 2024 John Paul Adrian Glaubitz <adrian.glaubitz@suse.com> - 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 Approximations), a derivative-free optimization solver, designed to supersede COBYLA, developed by the Department of Applied Mathematics, The Hong Kong Polytechnic University. * There are some performance improvements in `scipy.optimize.differential_evolution`. * `scipy.optimize.approx_fprime` now has linear space complexity. [#]`scipy.signal` improvements * `scipy.signal.minimum_phase` has a new argument ``half``, allowing the provision of a filter of the same length as the linear-phase FIR filter coefficients and with the same magnitude spectrum. [#]`scipy.sparse` improvements * Sparse arrays now support 1D shapes in COO, DOK and CSR formats. These are all the formats we currently intend to support 1D shapes. Other sparse array formats raise an exception for 1D input. * Sparse array methods min/nanmin/argmin and max analogs now return 1D arrays. Results are still COO format sparse arrays for min/nanmin and dense ``np.ndarray`` for argmin. * Sparse matrix and array objects improve their ``repr`` and ``str`` output. * A special case has been added to handle multiplying a ``dia_array`` by a scalar, which avoids a potentially costly conversion to CSR format. * `scipy.sparse.csgraph.yen` has been added, allowing usage of Yen's K-Shortest Paths algorithm on a directed on undirected graph. * Addition between DIA-format sparse arrays and matrices is now faster. * `scipy.sparse.linalg.spsolve_triangular` is now more than an order of magnitude faster in many cases. [#]`scipy.spatial` improvements * ``Rotation`` supports an alternative "scalar-first" convention of quaternion component ordering. It is available via the keyword argument ``scalar_first`` of ``from_quat`` and ``as_quat`` methods. * Some minor performance improvements for inverting of ``Rotation`` objects. [#]`scipy.special` improvements * Added `scipy.special.log_wright_bessel`, for calculation of the logarithm of Wright's Bessel function. * The relative error in `scipy.special.hyp2f1` calculations has improved substantially. * Improved behavior of ``boxcox``, ``inv_boxcox``, ``boxcox1p``, and ``inv_boxcox1p`` by preventing premature overflow. [#]`scipy.stats` improvements * A new function `scipy.stats.power` can be used for simulating the power of a hypothesis test with respect to a specified alternative. * The Irwin-Hall (AKA Uniform Sum) distribution has been added as `scipy.stats.irwinhall`. * Exact p-value calculations of `scipy.stats.mannwhitneyu` are much faster and use less memory. * `scipy.stats.pearsonr` now accepts n-D arrays and computes the statistic along a specified ``axis``. * `scipy.stats.kstat`, `scipy.stats.kstatvar`, and `scipy.stats.bartlett` are faster at performing calculations along an axis of a large n-D array. [#]# Array API Standard Support * Experimental* support for array libraries other than NumPy has been added to existing sub-packages in recent versions of SciPy. Please consider testing these features by setting an environment variable ``SCIPY_ARRAY_API=1`` and providing PyTorch, JAX, or CuPy arrays as array arguments. * As of 1.14.0, there is support for * `scipy.cluster` * `scipy.fft` * `scipy.constants` * `scipy.special`: (select functions) * `scipy.special.log_ndtr` * `scipy.special.ndtr` * `scipy.special.ndtri` * `scipy.special.erf` * `scipy.special.erfc` * `scipy.special.i0` * `scipy.special.i0e` * `scipy.special.i1` * `scipy.special.i1e` * `scipy.special.gammaln` * `scipy.special.gammainc` * `scipy.special.gammaincc` * `scipy.special.logit` * `scipy.special.expit` * `scipy.special.entr` * `scipy.special.rel_entr` * `scipy.special.xlogy` * `scipy.special.chdtrc` * `scipy.stats`: (select functions) * `scipy.stats.describe` * `scipy.stats.moment` * `scipy.stats.skew` * `scipy.stats.kurtosis` * `scipy.stats.kstat` * `scipy.stats.kstatvar` * `scipy.stats.circmean` * `scipy.stats.circvar` * `scipy.stats.circstd` * `scipy.stats.entropy` * `scipy.stats.variation` * `scipy.stats.sem` * `scipy.stats.ttest_1samp` * `scipy.stats.pearsonr` * `scipy.stats.chisquare` * `scipy.stats.skewtest` * `scipy.stats.kurtosistest` * `scipy.stats.normaltest` * `scipy.stats.jarque_bera` * `scipy.stats.bartlett` * `scipy.stats.power_divergence` * `scipy.stats.monte_carlo_test` [#]# Deprecated features * `scipy.stats.gstd`, `scipy.stats.chisquare`, and `scipy.stats.power_divergence` have deprecated support for masked array input. * `scipy.stats.linregress` has deprecated support for specifying both samples in one argument; ``x`` and ``y`` are to be provided as separate arguments. * The ``conjtransp`` method for `scipy.sparse.dok_array` and `scipy.sparse.dok_matrix` has been deprecated and will be removed in SciPy 1.16.0. * The option ``quadrature="trapz"`` in `scipy.integrate.quad_vec` has been deprecated in favour of ``quadrature="trapezoid"`` and will be removed in SciPy 1.16.0. * ``scipy.special.{comb,perm}`` have deprecated support for use of ``exact=True`` in conjunction with non-integral ``N`` and/or ``k``. [#]# Backwards incompatible changes * Many `scipy.stats` functions now produce a standardized warning message when an input sample is too small (e.g. zero size). Previously, these functions may have raised an error, emitted one or more less informative warnings, or emitted no warnings. In most cases, returned results are unchanged; in almost all cases the correct result is ``NaN``. [#]# Expired deprecations There is an ongoing effort to follow through on long-standing deprecations. The following previously deprecated features are affected: * Several previously deprecated methods for sparse arrays were removed: ``asfptype``, ``getrow``, ``getcol``, ``get_shape``, ``getmaxprint``, ``set_shape``, ``getnnz``, and ``getformat``. Additionally, the ``.A`` and ``.H`` attributes were removed. * ``scipy.integrate.{simps,trapz,cumtrapz}`` have been removed in favour of ``simpson``, ``trapezoid``, and ``cumulative_trapezoid``. * The ``tol`` argument of ``scipy.sparse.linalg.{bcg,bicstab,cg,cgs,gcrotmk, mres,lgmres,minres,qmr,tfqmr}`` has been removed in favour of ``rtol``. Furthermore, the default value of ``atol`` for these functions has changed to ``0.0``. * The ``restrt`` argument of `scipy.sparse.linalg.gmres` has been removed in favour of ``restart``. * The ``initial_lexsort`` argument of `scipy.stats.kendalltau` has been removed. * The ``cond`` and ``rcond`` arguments of `scipy.linalg.pinv` have been removed. * The ``even`` argument of `scipy.integrate.simpson` has been removed. * The ``turbo`` and ``eigvals`` arguments from ``scipy.linalg.{eigh,eigvalsh}`` have been removed. * The ``legacy`` argument of `scipy.special.comb` has been removed. * The ``hz``/``nyq`` argument of ``signal.{firls, firwin, firwin2, remez}`` has been removed. * Objects that weren't part of the public interface but were accessible through deprecated submodules have been removed. * ``float128``, ``float96``, and object arrays now raise an error in `scipy.signal.medfilt` and `scipy.signal.order_filter`. * ``scipy.interpolate.interp2d`` has been replaced by an empty stub (to be removed completely in the future). * Coinciding with changes to function signatures (e.g. removal of a deprecated keyword), we had deprecated positional use of keyword arguments for the affected functions, which will now raise an error. Affected functions are: * ``sparse.linalg.{bicg, bicgstab, cg, cgs, gcrotmk, gmres, lgmres, minres, qmr, tfqmr}`` * ``stats.kendalltau`` * ``linalg.pinv`` * ``integrate.simpson`` * ``linalg.{eigh,eigvalsh}`` * ``special.comb`` * ``signal.{firls, firwin, firwin2, remez}`` [#]# Other changes * SciPy now uses C17 as the C standard to build with, instead of C99. The C++ standard remains C++17. * macOS Accelerate, which got a major upgrade in macOS 13.3, is now supported. This results in significant performance improvements for linear algebra operations, as well as smaller binary wheels. * Cross-compilation should be smoother and QEMU or similar is no longer needed to run the cross interpreter. * Experimental array API support for the JAX backend has been added to several parts of SciPy. - Cherry-pick upstream patch to fix build with GCC 14 * https://github.com/scipy/scipy/pull/21063.patch - Update BuildRequires from pyproject.toml * Sun May 26 2024 Ben Greiner <code@bnavigator.de> - 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 * Sun May 12 2024 Sarah Kriesch <sarah.kriesch@opensuse.org> - Enable python-scipy:gnu-hpc for s390x (together with python-numpy:gnu-hpc) * Thu May 09 2024 Sarah Kriesch <sarah.kriesch@opensuse.org> - Enable openblas for s390x * Wed Apr 24 2024 Ben Greiner <code@bnavigator.de> - Skip another test out of numeric precision for 32-bit - Fix HPC _version * Fri Apr 19 2024 Ben Greiner <code@bnavigator.de> - 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 * Tue Feb 27 2024 Egbert Eich <eich@suse.com> - Add 8c96a1f742335bca283aae418763aaba62c03378.patch to fix issues with OpenBLAS 0.3.26 and later (boo#1220163). * Mon Jan 22 2024 Daniel Garcia <daniel.garcia@suse.com> - Disable broken tests in s390x, gh#scipy/scipy#18878, bsc#1218608 * Tue Nov 21 2023 Steve Kowalik <steven.kowalik@suse.com> - Update to 1.11.4: * MAINT: ensure cobyla objective returns scalar * MAINT: fixup dep warning * BUG: interpolate: fix spalde with len(c) < len(t) * BUG: pass unused xrtol in fmin_bfgs to _minimize_bfgs * BUG: Regression test for lsq trf boundary error * BUG: lsq trf gives x=1e-10 if x0 is near a bound * BUG: make Bessel-roots function not hang and not skip roots * io/matlab: Fix loading of mat files containing fn handles when simplify_cells=True * BUG: make L-BFGS-B work with single precision gradient * MAINT: stats: fix NumPy DeprecationWarnings * BUG: sparse.linalg: Cast to intc before SuperLU * MAINT: Use deb_system scheme to match meson's path inference & fix aarch64 * BUG: Fix python3.12 distutils dev.py build * BUG: stats: remove use of `BOOST_MATH_DECLARE_SPECIAL_FUNCTIONS` * MAINT: fix libquadmath licence * MAINT: newton, make sure x0 is an inexact type * MAINT: stats.CovViaEigendecomposition: fix _colorize for singular covariance * TST: fix `TestODR.test_implicit` test failure with tolerance bump * BUG: signal: freqz rfft grid fix * BUG: Support sparse arrays in scipy.sparse.csgraph.laplacian * MAINT: signal: Remove the cval parameter from the private function _pad_test. * BLD: Avoid absolute pathnames in .pyx files * BUG: Add back make_strictly_feasible to lsq trf. * MAINT: should not be using np.float64() on arrays * BUG: trust-constr Bounds exclusive * BUG: sparse.csgraph: Support int64 indices in traversal.pyx * BUG: add infeasibility checks to min_weight_full_bipartite_matching * DOC, MAINT: workaround for py311 docs * BUG: Fix typecasting problem in scipy.sparse.lil_matrix truediv * BUG: In least_squares make initial guess sufficiently feasible w.r.t. to bounds for method 'trf' * BUG: fix pow method for sparrays with power zero * BUG: set idx_dtype in sparse dia_array.tocoo - Drop patch intc.patch, included. * Mon Oct 09 2023 ecsos <ecsos@opensuse.org> - Let it build for Leap 15.6 also. * Thu Jul 27 2023 Markéta Machová <mmachova@suse.com> - Add upstream intc.patch to fix gh#scipy/scipy#18603 * Tue Jul 25 2023 Markéta Machová <mmachova@suse.com> - Update to 1.11.1 * 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 to a modern sparse array experience. * scipy.stats added tools for survival analysis, multiple hypothesis testing, sensitivity analysis, and working with censored data. * A new function was added for quasi-Monte Carlo integration, and linear algebra functions det and lu now accept nD-arrays. * An axes argument was added broadly to ndimage functions, facilitating analysis of stacked image data. * Thu Jun 29 2023 Andreas Schneider <asn@cryptomilk.org> - Use sle15_python_module_pythons - Require GCC >= 8 * Fri Mar 10 2023 Martin Liška <mliska@suse.cz> - Fix i686 tests for GCC 13 due to: https://gcc.gnu.org/gcc-13/porting_to.html#excess-precision * Sun Feb 26 2023 Ben Greiner <code@bnavigator.de> - Update to 1.10.1 * bug-fix release with no new features compared to 1.10.0 - Drop scipy-pr17717-ro-interpn.patch * Mon Jan 16 2023 Ben Greiner <code@bnavigator.de> - Highlights of the 1.10.0 release * A new dedicated datasets submodule (scipy.datasets) has been added, and is now preferred over usage of scipy.misc for dataset retrieval. * A new scipy.interpolate.make_smoothing_spline function was added. This function constructs a smoothing cubic spline from noisy data, using the generalized cross-validation (GCV) criterion to find the tradeoff between smoothness and proximity to data points. * scipy.stats has three new distributions, two new hypothesis tests, three new sample statistics, a class for greater control over calculations involving covariance matrices, and many other enhancements. - Add scipy-pr17717-ro-interpn.patch gh#scipy/scipy#17717 * Fixes gh#spacetelescope/gwcs#433 - Provide scipy-datasets.tar.gz for pooch cache and tests without needing to download during test time. * Wed Jan 11 2023 Guillaume GARDET <guillaume.gardet@opensuse.org> - Update to version 1.10.0 - Drop upstream pacthes: * fix-tests.patch * fix-tests-pytest72.patch * scipy-pr17467-no-np.int0.patch * Fri Dec 23 2022 Ben Greiner <code@bnavigator.de> - Add scipy-pr17467-no-np.int0.patch gh#scipy/scipy#17467 - Move the flavored packaganame definition so that quilt does not fail * Thu Dec 08 2022 Dominique Leuenberger <dimstar@opensuse.org> - Ensure the test flavor has a different source name than the main flavor: OBS uses the source names to create the dep-chain. With the test package having the same name as the mani flavor, all builds behind python-scipy are blocked until the test suite passed. * Wed Dec 07 2022 Daniel Garcia <daniel.garcia@suse.com> - Add fix-tests-pytest72.patch to fix the tests that fails with pytest 7 gh#scipy/scipy#17296 * Fri Dec 02 2022 Daniel Garcia <daniel.garcia@suse.com> - Add fix-tests.patch gh#scipy/scipy#16926#issuecomment-1287507634 * Thu Oct 20 2022 Ben Greiner <code@bnavigator.de> - Update to version 1.9.3 * SciPy 1.9.3 is a bug-fix release with no new features compared to 1.9.2. * #3691: scipy.interpolate.UnivariateSpline segfault * #5286: BUG: multivariate_normal returns a pdf for values outside its… * #6551: BUG: stats: inconsistency in docs and behavior of gmean and hmean * #9245: running scipy.interpolate.tests.test_fitpack::test_bisplev_integer_overflow… * #12471: test_bisplev_integer_overflow: Segmentation fault (core dumped) * #13321: Bug: setting iprint=0 hides all output from fmin_l_bfgs_b, but… * #13730: `scipy.stats.mood` does not correct for ties * #14019: ks_2samp throws `RuntimeWarning: overflow encountered in double_scalars` * #14589: `shgo` error since scipy 1.8.0.dev0+1529.803e52d * #14591: Input data validation for RectSphereBivariateSpline * #15101: BUG: binom.pmf - RuntimeWarning: divide by zero * #15342: BUG: scipy.optimize.minimize: Powell’s method function evaluated… * #15964: BUG: lombscargle fails if argument is a view * #16211: BUG: Possible bug when using winsorize on pandas data instead… * #16459: BUG: stats.ttest_ind returns wrong p-values with permutations * #16500: odr.Model default meta value fails with __getattr__ * #16519: BUG: Error in error message for incorrect sample dimension in… * #16527: BUG: dimension of isuppz in syevr is mistranslated * #16600: BUG: `KDTree`’s optional argument `eps` seems to have no… * #16656: dtype not preserved with operations on sparse arrays * #16751: BUG: `stats.fit` on `boltzmann` expects `bound` for `lambda`,… * #17012: BUG: Small oversight in sparse.linalg.lsmr? * #17020: BUG: Build failure due to problems with shebang line in cythoner.py * #17088: BUG: stats.rayleigh.fit: returns `loc` that is inconsistent… * #17104: BUG? Incorrect branch in `LAMV` / `_specfunc.lamv` * #17196: DOC: keepdims in stats.mode is incorrectly documented - Move multibuild flavor ":standard" to unflavored build - Test in parallel (pytest-xdist) * Tue Oct 11 2022 Ben Greiner <code@bnavigator.de> - Update to version 1.9.2 * SciPy 1.9.2 is a bug-fix release with no new features compared to 1.9.1. * Sat Sep 10 2022 Ben Greiner <code@bnavigator.de> - Update to version 1.9.1 * SciPy 1.9.1 is a bug-fix release with no new features compared to 1.9.0. Notably, some important meson build fixes are included. - Release 1.9.0 * Full changelog at https://docs.scipy.org/doc/scipy/release.1.9.0.html - Highlights of the 1.9.0 release: * We have modernized our build system to use meson, substantially improving our build performance, and providing better build-time configuration and cross-compilation support, * Added scipy.optimize.milp, new function for mixed-integer linear programming, * Added scipy.stats.fit for fitting discrete and continuous distributions to data, * Tensor-product spline interpolation modes were added to scipy.interpolate.RegularGridInterpolator, * A new global optimizer (DIviding RECTangles algorithm) scipy.optimize.direct. - Switch to meson-python PEP517 build * Mon Jul 18 2022 Ben Greiner <code@bnavigator.de> - Keep lowercase egg-info despite setuptools 60+ * Sat May 21 2022 andy great <andythe_great@pm.me> - Update to version 1.8.1. * Bug-fix release with no new features. * Tue Apr 12 2022 Martin Liška <mliska@suse.cz> - With the previously added -ffloat-store, some tests that fail on i586. Disable them. * Tue Apr 12 2022 Martin Liška <mliska@suse.cz> - Limit double floating point precision for x87, triggered by GCC 12. Fixes test_kolmogorov.py Fatal Python error: Floating point exception which is a double floating-point test. * Mon Mar 28 2022 Ben Greiner <code@bnavigator.de> - Update to version 1.8.0 * https://scipy.github.io/devdocs/release.1.8.0.html * SciPy 1.8.0 is the culmination of 6 months of hard work. It contains many new features, numerous bug-fixes, improved test coverage and better documentation. There have been a number of deprecations and API changes in this release. All users are encouraged to upgrade to this release, as there are a large number of bug-fixes and optimizations. Before upgrading, we recommend that users check that their own code does not use deprecated SciPy functionality (to do so, run your code with python -Wd and check for `DeprecationWarning`s). * A sparse array API has been added for early testing and feedback; this work is ongoing, and users should expect minor API refinements over the next few releases. * The sparse SVD library PROPACK is now vendored with SciPy, and an interface is exposed via scipy.sparse.svds with solver='PROPACK'. It is currently default-off due to potential issues on Windows that we aim to resolve in the next release, but can be optionally enabled at runtime for friendly testing with an environment variable setting of USE_PROPACK=1. * A new scipy.stats.sampling submodule that leverages the UNU.RAN C library to sample from arbitrary univariate non-uniform continuous and discrete distributions * All namespaces that were private but happened to miss underscores in their names have been deprecated. * Backwards incompatible changes - SciPy has raised the minimum compiler versions to GCC 6.3 on linux and VS2019 on windows. In particular, this means that SciPy may now use C99 and C++14 features. For more details see here. - The result for empty bins for scipy.stats.binned_statistic with the builtin 'std' metric is now nan, for consistency with np.std. - The function scipy.spatial.distance.wminkowski has been removed. To achieve the same results as before, please use the minkowski distance function with the (optional) w= keyword-argument for the given weight. * Sat Jan 29 2022 Ben Greiner <code@bnavigator.de> - Provide empty debuginfo extraction for :test flavor * Sun Jan 23 2022 Ben Greiner <code@bnavigator.de> - Update to version 1.7.3 * 3rd bugfix release since 1.7.0 - Highlights from the 1.7.0 release * A new submodule for quasi-Monte Carlo, scipy.stats.qmc, was added * The documentation design was updated to use the same PyData-Sphinx theme as NumPy and other ecosystem libraries. * We now vendor and leverage the Boost C++ library to enable numerous improvements for long-standing weaknesses in scipy.stats * scipy.stats has six new distributions, eight new (or overhauled) hypothesis tests, a new function for bootstrapping, a class that enables fast random variate sampling and percentile point function evaluation, and many other enhancements. * cdist and pdist distance calculations are faster for several metrics, especially weighted cases, thanks to a rewrite to a new C++ backend framework * A new class for radial basis function interpolation, RBFInterpolator, was added to address issues with the Rbf class. - Enable fast part of the test suite
/usr/share/doc/packages/python311-scipy-gnu-hpc /usr/share/doc/packages/python311-scipy-gnu-hpc/README.python311-scipy_1_13_1-gnu-hpc
Generated by rpm2html 1.8.1
Fabrice Bellet, Sun Jan 12 01:37:12 2025