SEARCH
NEW RPMS
DIRECTORIES
ABOUT
FAQ
VARIOUS
BLOG

 
 
Changelog for python310-scipy-1.10.1-1.1.x86_64.rpm :

* Fri Mar 10 2023 Martin Liška - 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 - 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 - 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 - 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 - 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 - 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 - Add fix-tests-pytest72.patch to fix the tests that fails with pytest 7 gh#scipy/scipy#17296
* Fri Dec 02 2022 Daniel Garcia - Add fix-tests.patch gh#scipy/scipy#16926#issuecomment-1287507634
* Thu Oct 20 2022 Ben Greiner - 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 - 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 - 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 - Keep lowercase egg-info despite setuptools 60+
* Sat May 21 2022 andy great - Update to version 1.8.1.
* Bug-fix release with no new features.
* Tue Apr 12 2022 Martin Liška - With the previously added -ffloat-store, some tests that fail on i586. Disable them.
* Tue Apr 12 2022 Martin Liška - 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 - 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 - Provide empty debuginfo extraction for :test flavor
* Sun Jan 23 2022 Ben Greiner - 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
* Mon Jul 26 2021 Andreas Schwab - Enable openblas on riscv64
* Mon May 03 2021 Arun Persaud - update to version 1.6.3:
* Issues closed + #13772: Divide by zero in distance.yule + #13796: CI: prerelease_deps failures + #13890: TST: spatial rotation failure in (1.6.3) wheels repo (ARM64)
* Pull requests + #13755: CI: fix the matplotlib warning emitted during builing docs + #13773: BUG: Divide by zero in yule dissimilarity of constant vectors + #13799: CI/MAINT: deprecated np.typeDict + #13819: substitute np.math.factorial with math.factorial + #13895: TST: add random seeds in Rotation module
* Sun Apr 04 2021 Arun Persaud - update to version 1.6.2:
* Issues closed for 1.6.2 + #13512: `stats.gaussian_kde.evaluate` broken on S390X + #13584: rotation._compute_euler_from_matrix() creates an array with negative... + #13585: Behavior change in coo_matrix when dtype=None + #13686: delta0 argument of scipy.odr.ODR() ignored
* Pull requests for 1.6.2 + #12862: REL: put upper bounds on versions of dependencies + #13575: BUG: fix `gaussian_kernel_estimate` on S390X + #13586: BUG: sparse: Create a utility function `getdata` + #13598: MAINT, BUG: enforce contiguous layout for output array in Rotation.as_euler + #13687: BUG: fix scipy.odr to consider given delta0 argument
* Wed Mar 03 2021 Arun Persaud - update to version 1.6.1:
* Issues closed + #13072: BLD: Quadpack undefined references + #13241: Not enough values to unpack when passing tuple to `blocksize`... + #13329: Large sparse matrices of big integers lose information + #13342: fftn crashes if shape arguments are supplied as ndarrays + #13356: LSQBivariateSpline segmentation fault when quitting the Python... + #13358: scipy.spatial.transform.Rotation object can not be deepcopied... + #13408: Type of `has_sorted_indices` property + #13412: Sorting spherical Voronoi vertices leads to crash in area calculation + #13421: linear_sum_assignment - support for matrices with more than 2^31... + #13428: `stats.exponnorm.cdf` returns `nan` for small values of `K`... + #13465: KDTree.count_neighbors : 0xC0000005 error for tuple of different... + #13468: directed_hausdorff issue with shuffle + #13472: Failures on FutureWarnings with numpy 1.20.0 for lfilter, sosfilt... + #13565: BUG: 32-bit wheels repo test failure in optimize
* Pull requests + #13318: REL: prepare for SciPy 1.6.1 + #13344: BUG: fftpack doesn\'t work with ndarray shape argument + #13345: MAINT: Replace scipy.take with numpy.take in FFT function docstrings. + #13354: BUG: optimize: rename private functions to include leading underscore + #13387: BUG: Support big-endian platforms and big-endian WAVs + #13394: BUG: Fix Python crash by allocating larger array in LSQBivariateSpline + #13400: BUG: sparse: Better validation for BSR ctor + #13403: BUG: sparse: Propagate dtype through CSR/CSC constructors + #13414: BUG: maintain dtype of SphericalVoronoi regions + #13422: FIX: optimize: use npy_intp to store array dims for lsap + #13425: BUG: spatial: make Rotation picklable + #13426: BUG: `has_sorted_indices` and `has_canonical_format` should... + #13430: BUG: stats: Fix exponnorm.cdf and exponnorm.sf for small K + #13470: MAINT: silence warning generated by `spatial.directed_hausdorff` + #13473: TST: fix failures due to new FutureWarnings in NumPy 1.21.dev0 + #13479: MAINT: update directed_hausdorff Cython code + #13485: BUG: KDTree weighted count_neighbors doesn\'t work between two... + #13503: TST: fix `test_fortranfile_read_mixed_record` on big-endian... + #13518: DOC: document that pip >= 20.3.3 is needed for macOS 11 + #13520: BLD: update reqs based on oldest-supported-numpy in pyproject.toml + #13567: TST, BUG: adjust tol on test_equivalence
* Sat Jan 16 2021 Benjamin Greiner - NEP 29: Last minorversion bump deprecated Python 3.6 https://numpy.org/neps/nep-0029-deprecation_policy.html- Fix hpc setup for coinstallable python3 flavors, needs gh#openSUSE/hpc#3
* Tue Jan 05 2021 Paolo Stivanin - Update to 1.6.0:
* scipy.ndimage improvements: Fixes and ehancements to boundary extension modes for interpolation functions. Support for complex-valued inputs in many filtering and interpolation functions. New grid_mode option for scipy.ndimage.zoom to enable results consistent with scikit-image’s rescale.
* scipy.optimize.linprog has fast, new methods for large, sparse problems from the HiGHS library.
* scipy.stats improvements including new distributions, a new test, and enhancements to existing distributions and tests
* scipy.special now has improved support for 64-bit LAPACK backend
* scipy.odr now has support for 64-bit integer BLAS
* scipy.odr.ODR has gained an optional overwrite argument so that existing files may be overwritten.
* scipy.cluster.hierarchy.DisjointSet has been added for incremental connectivity queries.
* scipy.cluster.hierarchy.dendrogram return value now also includes leaf color information in leaves_color_list.
* scipy.interpolate.interp1d has a new method nearest-up, similar to the existing method nearest but rounds half-integers up instead of down.
* scipy.ndimage.convolve, scipy.ndimage.correlate and their 1d counterparts now accept both complex-valued images and/or complex-valued filter kernels. All convolution-based filters also now accept complex-valued inputs
* scipy.optimize.linprog has fast, new methods for large, sparse problems from the HiGHS C++ library
* scipy.optimize.quadratic_assignment has been added for approximate solution of the quadratic assignment problem.
* scipy.optimize.linear_sum_assignment now has a substantially reduced overhead for small cost matrix sizes
* scipy.optimize.least_squares has improved performance when the user provides the jacobian as a sparse jacobian already in csr_matrix format
* scipy.signal.gammatone has been added to design FIR or IIR filters that model the human auditory system.
* scipy.signal.iircomb has been added to design IIR peaking/notching comb filters that can boost/attenuate a frequency from a signal.
* scipy.signal.sosfilt performance has been improved to avoid some previously- observed slowdowns
* scipy.signal.windows.taylor has been added–the Taylor window function is commonly used in radar digital signal processing
* scipy.signal.gauss_spline now supports list type input for consistency with other related SciPy functions
* scipy.signal.correlation_lags has been added to allow calculation of the lag/ displacement indices array for 1D cross-correlation.
* Fri Dec 18 2020 andy great - Update to version 1.5.4.
* Bug fix release with no new feature.- Updates for 1.5.3.
* Bug fix release with no new feature.
* Thu Aug 13 2020 Marketa Calabkova - Update to 1.5.2
* wrappers for more than a dozen new LAPACK routines are now available in scipy.linalg.lapack
* Improved support for leveraging 64-bit integer size from linear algebra backends
* addition of the probability distribution for two-sided one-sample Kolmogorov-Smirnov tests
* see upstream changelog for more detailed info- Drop breaking patch no_implicit_decl.patch
* the problem is with lapacke
* Thu Mar 19 2020 Martin Liška - Add -std=legacy in order to build with GCC10: https://gcc.gnu.org/gcc-10/porting_to.html#argument-mismatch
* Mon Mar 16 2020 Egbert Eich - \'umpfack\' is a runtime dependency of scipy. No build time dependency to suitesparse is required (jsc#SLE-11732).- Get rid of site.cfg entirely as it is used nowhwere in scipy.
* Wed Jan 15 2020 Tomáš Chvátal - Fix pybind11 devel dependency to match real name
 
ICM