scipy 1.9.1 failures on macOS 12.5.1 with M1
I am running `scipy.test()` on my SciPy 1.9.1 installation (from conda-forge) and depending on which version of OpenBLAS I use (also from conda-forge), I get different results: For OpenBLAS 0.3.21 (openmp_hf78f355_3) I see: ======================================================================== FAILED fft/_pocketfft/tests/test_real_transforms.py::test_dst4_definition_ortho[1-float32] - AssertionError: FAILED linalg/tests/test_solvers.py::test_solve_discrete_are - AssertionError: FAILED ndimage/tests/test_datatypes.py::test_uint64_max - AssertionError FAILED sparse/linalg/_isolve/tests/test_iterative.py::test_maxiter_worsening[gmres] - AssertionError FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_a_b_neg_int_after_euler_hypergeometric_transformation[hyp2f1_test_case0] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case30] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case34] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case47] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region5[hyp2f1_test_case3] - AssertionError: =========================== 9 failed, 37060 passed, 3306 skipped, 12055 deselected, 137 xfailed, 11 xpassed, 86 warnings in 340.02s (0:05:40) =========================== For OpenBLAS 0.3.20 (openmp_h7efc2c9_1) I see: ======================================================================== FAILED fft/_pocketfft/tests/test_real_transforms.py::test_dst4_definition_ortho[1-float32] - AssertionError: FAILED linalg/tests/test_basic.py::TestSolve::test_simple_her_actuallysym - AssertionError: FAILED linalg/tests/test_basic.py::TestLstsq::test_simple_overdet_complex - AssertionError: FAILED linalg/tests/test_basic.py::TestLstsq::test_random_complex_exact - AssertionError: FAILED linalg/tests/test_basic.py::TestLstsq::test_random_complex_overdet - AssertionError: FAILED linalg/tests/test_blas.py::TestFBLAS2Simple::test_syr_her - AssertionError: FAILED linalg/tests/test_decomp.py::TestEig::test_make_eigvals - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigBanded::test_zhbevd - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigBanded::test_zhbevx - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigBanded::test_eig_banded - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[ev-complex64] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[ev-complex128] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evd-complex64] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evd-complex128] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evx-complex64] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evx-complex128] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestSVD_GESVD::test_simple_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestSVD_GESVD::test_random_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestQZ::test_qz_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestQZ::test_qz_complex64 - AssertionError: FAILED linalg/tests/test_decomp.py::TestQZ::test_qz_double_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_lhp - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_rhp - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_iuc - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_ouc - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_ref - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_cef - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZWorkspaceSize::test_decompose - ValueError: Reordering of (A, B) failed because the transformed matrix pair (A, B) would ... FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-4-2-2-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-4-2-2-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-40-12-20-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-40-12-20-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-100-50-50-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-100-50-50-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-4-2-2-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-4-2-2-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-40-12-20-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-40-12-20-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-100-50-50-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-100-50-50-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin_mixed_types - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_simple - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[30-complex64] - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[30-complex128] - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[150-complex64] - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[150-complex128] - AssertionError: FAILED linalg/tests/test_lapack.py::TestLeastSquaresSolvers::test_gelsd - AssertionError: FAILED linalg/tests/test_lapack.py::TestBlockedQR::test_tpqrt_tpmqrt - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[1-complex64-float32] - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[1-complex128-float64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[2-complex64-float32] - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[2-complex128-float64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_orcsd_uncsd[complex64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_orcsd_uncsd[complex128] - AssertionError: FAILED linalg/tests/test_lapack.py::test_gges_tgexc[complex64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_gges_tgexc[complex128] - AssertionError: FAILED linalg/tests/test_solvers.py::test_solve_discrete_are - numpy.linalg.LinAlgError: The associated symplectic pencil has eigenvaluestoo close to the unit circle FAILED ndimage/tests/test_datatypes.py::test_uint64_max - AssertionError FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_hermitian_modes - scipy.sparse.linalg._eigen.arpack.arpack.ArpackError: ARPACK error -8: Error return fr... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_real_nonsymmetric_modes - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did not converge (L... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_complex_nonsymmetric_modes - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did not converge... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_standard_nonsymmetric_starting_vector - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did n... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_general_nonsymmetric_starting_vector - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did no... FAILED sparse/linalg/_eigen/lobpcg/tests/test_lobpcg.py::test_hermitian - AssertionError: FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_ARPACK::test_svd_linop - scipy.sparse.linalg._eigen.arpack.arpack.ArpackError: ARPACK error -8: Error return... FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_LOBPCG::test_small_sigma_sparse[complex-shape0] - ValueError: array must not contain infs or NaNs FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_LOBPCG::test_small_sigma_sparse[complex-shape1] - ValueError: array must not contain infs or NaNs FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_LOBPCG::test_small_sigma_sparse[complex-shape2] - ValueError: array must not contain infs or NaNs FAILED sparse/linalg/_isolve/tests/test_iterative.py::test_maxiter_worsening[gmres] - AssertionError FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_a_b_neg_int_after_euler_hypergeometric_transformation[hyp2f1_test_case0] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case30] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case34] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case47] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region5[hyp2f1_test_case3] - AssertionError: ========================== 90 failed, 36979 passed, 3306 skipped, 12055 deselected, 138 xfailed, 10 xpassed, 98 warnings in 292.97s (0:04:52) =========================== On my Linux aarch64 machine all tests pass. So I guess my questions are: 1) Is it possible that these 90 failures are due to OpenBLAS? Or is it something else that SciPy uses? As the number of failures went from 90 to 9 I am inclined to believe so but I am not a dev. 2) How can I further debug the 9 failures? If they are indeed due to OpenBLAS then it's possible that the latest version fixed a bunch of things but not everything, so in order to further help them I guess it would be better if we provide minimal reproducible examples? Apologies in advance for any mistakes and happy to provide any further information.
Hi, I think it’s a known problem and we have a few issues tracking OpenBlas related things. E.g. https://github.com/scipy/scipy/issues/16767 <https://github.com/scipy/scipy/issues/16767>, https://github.com/scipy/scipy/issues/16926 <https://github.com/scipy/scipy/issues/16926> and https://github.com/scipy/scipy/issues/16949 <https://github.com/scipy/scipy/issues/16949> Cheers, Pamphile
On 07.09.2022, at 22:26, Babar Mehta <babar19172020@gmail.com> wrote:
I am running `scipy.test()` on my SciPy 1.9.1 installation (from conda-forge) and depending on which version of OpenBLAS I use (also from conda-forge), I get different results:
For OpenBLAS 0.3.21 (openmp_hf78f355_3) I see: ======================================================================== FAILED fft/_pocketfft/tests/test_real_transforms.py::test_dst4_definition_ortho[1-float32] - AssertionError: FAILED linalg/tests/test_solvers.py::test_solve_discrete_are - AssertionError: FAILED ndimage/tests/test_datatypes.py::test_uint64_max - AssertionError FAILED sparse/linalg/_isolve/tests/test_iterative.py::test_maxiter_worsening[gmres] - AssertionError FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_a_b_neg_int_after_euler_hypergeometric_transformation[hyp2f1_test_case0] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case30] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case34] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case47] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region5[hyp2f1_test_case3] - AssertionError: =========================== 9 failed, 37060 passed, 3306 skipped, 12055 deselected, 137 xfailed, 11 xpassed, 86 warnings in 340.02s (0:05:40) ===========================
For OpenBLAS 0.3.20 (openmp_h7efc2c9_1) I see: ======================================================================== FAILED fft/_pocketfft/tests/test_real_transforms.py::test_dst4_definition_ortho[1-float32] - AssertionError: FAILED linalg/tests/test_basic.py::TestSolve::test_simple_her_actuallysym - AssertionError: FAILED linalg/tests/test_basic.py::TestLstsq::test_simple_overdet_complex - AssertionError: FAILED linalg/tests/test_basic.py::TestLstsq::test_random_complex_exact - AssertionError: FAILED linalg/tests/test_basic.py::TestLstsq::test_random_complex_overdet - AssertionError: FAILED linalg/tests/test_blas.py::TestFBLAS2Simple::test_syr_her - AssertionError: FAILED linalg/tests/test_decomp.py::TestEig::test_make_eigvals - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigBanded::test_zhbevd - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigBanded::test_zhbevx - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigBanded::test_eig_banded - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[ev-complex64] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[ev-complex128] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evd-complex64] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evd-complex128] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evx-complex64] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_various_drivers_standard[evx-complex128] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-True-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-F-False-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-True-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-True-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-True-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-False-True-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestEigh::test_eigh[6-D-False-False-False-None] - AssertionError: FAILED linalg/tests/test_decomp.py::TestSVD_GESVD::test_simple_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestSVD_GESVD::test_random_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestQZ::test_qz_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestQZ::test_qz_complex64 - AssertionError: FAILED linalg/tests/test_decomp.py::TestQZ::test_qz_double_complex - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_lhp - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_rhp - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_iuc - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_ouc - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_ref - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZ::test_cef - AssertionError: FAILED linalg/tests/test_decomp.py::TestOrdQZWorkspaceSize::test_decompose - ValueError: Reordering of (A, B) failed because the transformed matrix pair (A, B) would ... FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-4-2-2-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-4-2-2-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-40-12-20-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-40-12-20-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-100-50-50-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[True-100-50-50-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-4-2-2-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-4-2-2-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-40-12-20-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-40-12-20-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-100-50-50-complex64] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin[False-100-50-50-complex128] - AssertionError: FAILED linalg/tests/test_decomp_cossin.py::test_cossin_mixed_types - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_simple - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[30-complex64] - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[30-complex128] - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[150-complex64] - AssertionError: FAILED linalg/tests/test_decomp_ldl.py::test_ldl_type_size_combinations_complex[150-complex128] - AssertionError: FAILED linalg/tests/test_lapack.py::TestLeastSquaresSolvers::test_gelsd - AssertionError: FAILED linalg/tests/test_lapack.py::TestBlockedQR::test_tpqrt_tpmqrt - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[1-complex64-float32] - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[1-complex128-float64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[2-complex64-float32] - AssertionError: FAILED linalg/tests/test_lapack.py::test_pteqr[2-complex128-float64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_orcsd_uncsd[complex64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_orcsd_uncsd[complex128] - AssertionError: FAILED linalg/tests/test_lapack.py::test_gges_tgexc[complex64] - AssertionError: FAILED linalg/tests/test_lapack.py::test_gges_tgexc[complex128] - AssertionError: FAILED linalg/tests/test_solvers.py::test_solve_discrete_are - numpy.linalg.LinAlgError: The associated symplectic pencil has eigenvaluestoo close to the unit circle FAILED ndimage/tests/test_datatypes.py::test_uint64_max - AssertionError FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_hermitian_modes - scipy.sparse.linalg._eigen.arpack.arpack.ArpackError: ARPACK error -8: Error return fr... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_real_nonsymmetric_modes - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did not converge (L... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_complex_nonsymmetric_modes - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did not converge... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_standard_nonsymmetric_starting_vector - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did n... FAILED sparse/linalg/_eigen/arpack/tests/test_arpack.py::test_general_nonsymmetric_starting_vector - numpy.linalg.LinAlgError: generalized eig algorithm (ggev) did no... FAILED sparse/linalg/_eigen/lobpcg/tests/test_lobpcg.py::test_hermitian - AssertionError: FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_ARPACK::test_svd_linop - scipy.sparse.linalg._eigen.arpack.arpack.ArpackError: ARPACK error -8: Error return... FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_LOBPCG::test_small_sigma_sparse[complex-shape0] - ValueError: array must not contain infs or NaNs FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_LOBPCG::test_small_sigma_sparse[complex-shape1] - ValueError: array must not contain infs or NaNs FAILED sparse/linalg/_eigen/tests/test_svds.py::Test_SVDS_LOBPCG::test_small_sigma_sparse[complex-shape2] - ValueError: array must not contain infs or NaNs FAILED sparse/linalg/_isolve/tests/test_iterative.py::test_maxiter_worsening[gmres] - AssertionError FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_a_b_neg_int_after_euler_hypergeometric_transformation[hyp2f1_test_case0] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case30] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case34] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region4[hyp2f1_test_case47] - AssertionError: FAILED special/tests/test_hyp2f1.py::TestHyp2f1::test_region5[hyp2f1_test_case3] - AssertionError: ========================== 90 failed, 36979 passed, 3306 skipped, 12055 deselected, 138 xfailed, 10 xpassed, 98 warnings in 292.97s (0:04:52) ===========================
On my Linux aarch64 machine all tests pass. So I guess my questions are:
1) Is it possible that these 90 failures are due to OpenBLAS? Or is it something else that SciPy uses? As the number of failures went from 90 to 9 I am inclined to believe so but I am not a dev. 2) How can I further debug the 9 failures? If they are indeed due to OpenBLAS then it's possible that the latest version fixed a bunch of things but not everything, so in order to further help them I guess it would be better if we provide minimal reproducible examples?
Apologies in advance for any mistakes and happy to provide any further information. _______________________________________________ SciPy-Dev mailing list -- scipy-dev@python.org To unsubscribe send an email to scipy-dev-leave@python.org https://mail.python.org/mailman3/lists/scipy-dev.python.org/ Member address: roy.pamphile@gmail.com
Hi, Thanks for the response, I will look into those issues. Good to know that someone else is also looking at it!!!
participants (2)
-
Babar Mehta
-
Pamphile Roy