scipy 1.15.3__cp313-cp313t-macosx_14_0_arm64.whl → 1.16.0rc2__cp313-cp313t-macosx_14_0_arm64.whl
This diff represents the content of publicly available package versions that have been released to one of the supported registries. The information contained in this diff is provided for informational purposes only and reflects changes between package versions as they appear in their respective public registries.
- scipy/__config__.py +3 -3
- scipy/__init__.py +3 -6
- scipy/_cyutility.cpython-313t-darwin.so +0 -0
- scipy/_lib/_array_api.py +486 -161
- scipy/_lib/_array_api_compat_vendor.py +9 -0
- scipy/_lib/_bunch.py +4 -0
- scipy/_lib/_ccallback_c.cpython-313t-darwin.so +0 -0
- scipy/_lib/_docscrape.py +1 -1
- scipy/_lib/_elementwise_iterative_method.py +15 -26
- scipy/_lib/_sparse.py +41 -0
- scipy/_lib/_test_deprecation_call.cpython-313t-darwin.so +0 -0
- scipy/_lib/_testutils.py +6 -2
- scipy/_lib/_util.py +222 -125
- scipy/_lib/array_api_compat/__init__.py +4 -4
- scipy/_lib/array_api_compat/_internal.py +19 -6
- scipy/_lib/array_api_compat/common/__init__.py +1 -1
- scipy/_lib/array_api_compat/common/_aliases.py +365 -193
- scipy/_lib/array_api_compat/common/_fft.py +94 -64
- scipy/_lib/array_api_compat/common/_helpers.py +413 -180
- scipy/_lib/array_api_compat/common/_linalg.py +116 -40
- scipy/_lib/array_api_compat/common/_typing.py +179 -10
- scipy/_lib/array_api_compat/cupy/__init__.py +1 -4
- scipy/_lib/array_api_compat/cupy/_aliases.py +61 -41
- scipy/_lib/array_api_compat/cupy/_info.py +16 -6
- scipy/_lib/array_api_compat/cupy/_typing.py +24 -39
- scipy/_lib/array_api_compat/dask/array/__init__.py +6 -3
- scipy/_lib/array_api_compat/dask/array/_aliases.py +267 -108
- scipy/_lib/array_api_compat/dask/array/_info.py +105 -34
- scipy/_lib/array_api_compat/dask/array/fft.py +5 -8
- scipy/_lib/array_api_compat/dask/array/linalg.py +21 -22
- scipy/_lib/array_api_compat/numpy/__init__.py +13 -15
- scipy/_lib/array_api_compat/numpy/_aliases.py +98 -49
- scipy/_lib/array_api_compat/numpy/_info.py +36 -16
- scipy/_lib/array_api_compat/numpy/_typing.py +27 -43
- scipy/_lib/array_api_compat/numpy/fft.py +11 -5
- scipy/_lib/array_api_compat/numpy/linalg.py +75 -22
- scipy/_lib/array_api_compat/torch/__init__.py +3 -5
- scipy/_lib/array_api_compat/torch/_aliases.py +262 -159
- scipy/_lib/array_api_compat/torch/_info.py +27 -16
- scipy/_lib/array_api_compat/torch/_typing.py +3 -0
- scipy/_lib/array_api_compat/torch/fft.py +17 -18
- scipy/_lib/array_api_compat/torch/linalg.py +16 -16
- scipy/_lib/array_api_extra/__init__.py +26 -3
- scipy/_lib/array_api_extra/_delegation.py +171 -0
- scipy/_lib/array_api_extra/_lib/__init__.py +1 -0
- scipy/_lib/array_api_extra/_lib/_at.py +463 -0
- scipy/_lib/array_api_extra/_lib/_backends.py +46 -0
- scipy/_lib/array_api_extra/_lib/_funcs.py +937 -0
- scipy/_lib/array_api_extra/_lib/_lazy.py +357 -0
- scipy/_lib/array_api_extra/_lib/_testing.py +278 -0
- scipy/_lib/array_api_extra/_lib/_utils/__init__.py +1 -0
- scipy/_lib/array_api_extra/_lib/_utils/_compat.py +74 -0
- scipy/_lib/array_api_extra/_lib/_utils/_compat.pyi +45 -0
- scipy/_lib/array_api_extra/_lib/_utils/_helpers.py +559 -0
- scipy/_lib/array_api_extra/_lib/_utils/_typing.py +10 -0
- scipy/_lib/array_api_extra/_lib/_utils/_typing.pyi +105 -0
- scipy/_lib/array_api_extra/testing.py +359 -0
- scipy/_lib/decorator.py +2 -2
- scipy/_lib/doccer.py +1 -7
- scipy/_lib/messagestream.cpython-313t-darwin.so +0 -0
- scipy/_lib/pyprima/__init__.py +212 -0
- scipy/_lib/pyprima/cobyla/__init__.py +0 -0
- scipy/_lib/pyprima/cobyla/cobyla.py +559 -0
- scipy/_lib/pyprima/cobyla/cobylb.py +714 -0
- scipy/_lib/pyprima/cobyla/geometry.py +226 -0
- scipy/_lib/pyprima/cobyla/initialize.py +215 -0
- scipy/_lib/pyprima/cobyla/trustregion.py +492 -0
- scipy/_lib/pyprima/cobyla/update.py +289 -0
- scipy/_lib/pyprima/common/__init__.py +0 -0
- scipy/_lib/pyprima/common/_bounds.py +34 -0
- scipy/_lib/pyprima/common/_linear_constraints.py +46 -0
- scipy/_lib/pyprima/common/_nonlinear_constraints.py +54 -0
- scipy/_lib/pyprima/common/_project.py +173 -0
- scipy/_lib/pyprima/common/checkbreak.py +93 -0
- scipy/_lib/pyprima/common/consts.py +47 -0
- scipy/_lib/pyprima/common/evaluate.py +99 -0
- scipy/_lib/pyprima/common/history.py +38 -0
- scipy/_lib/pyprima/common/infos.py +30 -0
- scipy/_lib/pyprima/common/linalg.py +435 -0
- scipy/_lib/pyprima/common/message.py +290 -0
- scipy/_lib/pyprima/common/powalg.py +131 -0
- scipy/_lib/pyprima/common/preproc.py +277 -0
- scipy/_lib/pyprima/common/present.py +5 -0
- scipy/_lib/pyprima/common/ratio.py +54 -0
- scipy/_lib/pyprima/common/redrho.py +47 -0
- scipy/_lib/pyprima/common/selectx.py +296 -0
- scipy/_lib/tests/test__util.py +105 -121
- scipy/_lib/tests/test_array_api.py +166 -35
- scipy/_lib/tests/test_bunch.py +7 -0
- scipy/_lib/tests/test_ccallback.py +2 -10
- scipy/_lib/tests/test_public_api.py +13 -0
- scipy/cluster/_hierarchy.cpython-313t-darwin.so +0 -0
- scipy/cluster/_optimal_leaf_ordering.cpython-313t-darwin.so +0 -0
- scipy/cluster/_vq.cpython-313t-darwin.so +0 -0
- scipy/cluster/hierarchy.py +393 -223
- scipy/cluster/tests/test_hierarchy.py +273 -335
- scipy/cluster/tests/test_vq.py +45 -61
- scipy/cluster/vq.py +39 -35
- scipy/conftest.py +263 -157
- scipy/constants/_constants.py +4 -1
- scipy/constants/tests/test_codata.py +2 -2
- scipy/constants/tests/test_constants.py +11 -18
- scipy/datasets/_download_all.py +15 -1
- scipy/datasets/_fetchers.py +7 -1
- scipy/datasets/_utils.py +1 -1
- scipy/differentiate/_differentiate.py +25 -25
- scipy/differentiate/tests/test_differentiate.py +24 -25
- scipy/fft/_basic.py +20 -0
- scipy/fft/_helper.py +3 -34
- scipy/fft/_pocketfft/helper.py +29 -1
- scipy/fft/_pocketfft/tests/test_basic.py +2 -4
- scipy/fft/_pocketfft/tests/test_real_transforms.py +4 -4
- scipy/fft/_realtransforms.py +13 -0
- scipy/fft/tests/test_basic.py +27 -25
- scipy/fft/tests/test_fftlog.py +16 -7
- scipy/fft/tests/test_helper.py +18 -34
- scipy/fft/tests/test_real_transforms.py +8 -10
- scipy/fftpack/convolve.cpython-313t-darwin.so +0 -0
- scipy/fftpack/tests/test_basic.py +2 -4
- scipy/fftpack/tests/test_real_transforms.py +8 -9
- scipy/integrate/_bvp.py +9 -3
- scipy/integrate/_cubature.py +3 -2
- scipy/integrate/_dop.cpython-313t-darwin.so +0 -0
- scipy/integrate/_lsoda.cpython-313t-darwin.so +0 -0
- scipy/integrate/_ode.py +9 -2
- scipy/integrate/_odepack.cpython-313t-darwin.so +0 -0
- scipy/integrate/_quad_vec.py +21 -29
- scipy/integrate/_quadpack.cpython-313t-darwin.so +0 -0
- scipy/integrate/_quadpack_py.py +11 -7
- scipy/integrate/_quadrature.py +3 -3
- scipy/integrate/_rules/_base.py +2 -2
- scipy/integrate/_tanhsinh.py +48 -47
- scipy/integrate/_test_odeint_banded.cpython-313t-darwin.so +0 -0
- scipy/integrate/_vode.cpython-313t-darwin.so +0 -0
- scipy/integrate/tests/test__quad_vec.py +0 -6
- scipy/integrate/tests/test_banded_ode_solvers.py +85 -0
- scipy/integrate/tests/test_cubature.py +21 -35
- scipy/integrate/tests/test_quadrature.py +6 -8
- scipy/integrate/tests/test_tanhsinh.py +56 -48
- scipy/interpolate/__init__.py +70 -58
- scipy/interpolate/_bary_rational.py +22 -22
- scipy/interpolate/_bsplines.py +119 -66
- scipy/interpolate/_cubic.py +65 -50
- scipy/interpolate/_dfitpack.cpython-313t-darwin.so +0 -0
- scipy/interpolate/_dierckx.cpython-313t-darwin.so +0 -0
- scipy/interpolate/_fitpack.cpython-313t-darwin.so +0 -0
- scipy/interpolate/_fitpack2.py +9 -6
- scipy/interpolate/_fitpack_impl.py +32 -26
- scipy/interpolate/_fitpack_repro.py +23 -19
- scipy/interpolate/_interpnd.cpython-313t-darwin.so +0 -0
- scipy/interpolate/_interpolate.py +30 -12
- scipy/interpolate/_ndbspline.py +13 -18
- scipy/interpolate/_ndgriddata.py +5 -8
- scipy/interpolate/_polyint.py +95 -31
- scipy/interpolate/_ppoly.cpython-313t-darwin.so +0 -0
- scipy/interpolate/_rbf.py +2 -2
- scipy/interpolate/_rbfinterp.py +1 -1
- scipy/interpolate/_rbfinterp_pythran.cpython-313t-darwin.so +0 -0
- scipy/interpolate/_rgi.py +31 -26
- scipy/interpolate/_rgi_cython.cpython-313t-darwin.so +0 -0
- scipy/interpolate/dfitpack.py +0 -20
- scipy/interpolate/interpnd.py +1 -2
- scipy/interpolate/tests/test_bary_rational.py +2 -2
- scipy/interpolate/tests/test_bsplines.py +97 -1
- scipy/interpolate/tests/test_fitpack2.py +39 -1
- scipy/interpolate/tests/test_interpnd.py +32 -20
- scipy/interpolate/tests/test_interpolate.py +48 -4
- scipy/interpolate/tests/test_rgi.py +2 -1
- scipy/io/_fast_matrix_market/__init__.py +2 -0
- scipy/io/_harwell_boeing/_fortran_format_parser.py +19 -16
- scipy/io/_harwell_boeing/hb.py +7 -11
- scipy/io/_idl.py +5 -7
- scipy/io/_netcdf.py +15 -5
- scipy/io/_test_fortran.cpython-313t-darwin.so +0 -0
- scipy/io/arff/tests/test_arffread.py +3 -3
- scipy/io/matlab/__init__.py +5 -3
- scipy/io/matlab/_mio.py +4 -1
- scipy/io/matlab/_mio5.py +19 -13
- scipy/io/matlab/_mio5_utils.cpython-313t-darwin.so +0 -0
- scipy/io/matlab/_mio_utils.cpython-313t-darwin.so +0 -0
- scipy/io/matlab/_miobase.py +4 -1
- scipy/io/matlab/_streams.cpython-313t-darwin.so +0 -0
- scipy/io/matlab/tests/test_mio.py +46 -18
- scipy/io/matlab/tests/test_mio_funcs.py +1 -1
- scipy/io/tests/test_mmio.py +7 -1
- scipy/io/tests/test_wavfile.py +41 -0
- scipy/io/wavfile.py +57 -10
- scipy/linalg/_basic.py +113 -86
- scipy/linalg/_cythonized_array_utils.cpython-313t-darwin.so +0 -0
- scipy/linalg/_decomp.py +22 -9
- scipy/linalg/_decomp_cholesky.py +28 -13
- scipy/linalg/_decomp_cossin.py +45 -30
- scipy/linalg/_decomp_interpolative.cpython-313t-darwin.so +0 -0
- scipy/linalg/_decomp_ldl.py +4 -1
- scipy/linalg/_decomp_lu.py +18 -6
- scipy/linalg/_decomp_lu_cython.cpython-313t-darwin.so +0 -0
- scipy/linalg/_decomp_polar.py +2 -0
- scipy/linalg/_decomp_qr.py +6 -2
- scipy/linalg/_decomp_qz.py +3 -0
- scipy/linalg/_decomp_schur.py +3 -1
- scipy/linalg/_decomp_svd.py +13 -2
- scipy/linalg/_decomp_update.cpython-313t-darwin.so +0 -0
- scipy/linalg/_expm_frechet.py +4 -0
- scipy/linalg/_fblas.cpython-313t-darwin.so +0 -0
- scipy/linalg/_flapack.cpython-313t-darwin.so +0 -0
- scipy/linalg/_linalg_pythran.cpython-313t-darwin.so +0 -0
- scipy/linalg/_matfuncs.py +187 -4
- scipy/linalg/_matfuncs_expm.cpython-313t-darwin.so +0 -0
- scipy/linalg/_matfuncs_schur_sqrtm.cpython-313t-darwin.so +0 -0
- scipy/linalg/_matfuncs_sqrtm.py +1 -99
- scipy/linalg/_matfuncs_sqrtm_triu.cpython-313t-darwin.so +0 -0
- scipy/linalg/_procrustes.py +2 -0
- scipy/linalg/_sketches.py +17 -6
- scipy/linalg/_solve_toeplitz.cpython-313t-darwin.so +0 -0
- scipy/linalg/_solvers.py +7 -2
- scipy/linalg/_special_matrices.py +26 -36
- scipy/linalg/cython_blas.cpython-313t-darwin.so +0 -0
- scipy/linalg/cython_lapack.cpython-313t-darwin.so +0 -0
- scipy/linalg/lapack.py +22 -2
- scipy/linalg/tests/_cython_examples/meson.build +7 -0
- scipy/linalg/tests/test_basic.py +31 -16
- scipy/linalg/tests/test_batch.py +588 -0
- scipy/linalg/tests/test_cythonized_array_utils.py +0 -2
- scipy/linalg/tests/test_decomp.py +40 -3
- scipy/linalg/tests/test_decomp_cossin.py +14 -0
- scipy/linalg/tests/test_decomp_ldl.py +1 -1
- scipy/linalg/tests/test_lapack.py +115 -7
- scipy/linalg/tests/test_matfuncs.py +157 -102
- scipy/linalg/tests/test_procrustes.py +0 -7
- scipy/linalg/tests/test_solve_toeplitz.py +1 -1
- scipy/linalg/tests/test_special_matrices.py +1 -5
- scipy/ndimage/__init__.py +1 -0
- scipy/ndimage/_cytest.cpython-313t-darwin.so +0 -0
- scipy/ndimage/_delegators.py +8 -2
- scipy/ndimage/_filters.py +453 -5
- scipy/ndimage/_interpolation.py +36 -6
- scipy/ndimage/_measurements.py +4 -2
- scipy/ndimage/_morphology.py +5 -0
- scipy/ndimage/_nd_image.cpython-313t-darwin.so +0 -0
- scipy/ndimage/_ni_docstrings.py +5 -1
- scipy/ndimage/_ni_label.cpython-313t-darwin.so +0 -0
- scipy/ndimage/_ni_support.py +1 -5
- scipy/ndimage/_rank_filter_1d.cpython-313t-darwin.so +0 -0
- scipy/ndimage/_support_alternative_backends.py +18 -6
- scipy/ndimage/tests/test_filters.py +370 -259
- scipy/ndimage/tests/test_fourier.py +7 -9
- scipy/ndimage/tests/test_interpolation.py +68 -61
- scipy/ndimage/tests/test_measurements.py +18 -35
- scipy/ndimage/tests/test_morphology.py +143 -131
- scipy/ndimage/tests/test_splines.py +1 -3
- scipy/odr/__odrpack.cpython-313t-darwin.so +0 -0
- scipy/optimize/_basinhopping.py +13 -7
- scipy/optimize/_bglu_dense.cpython-313t-darwin.so +0 -0
- scipy/optimize/_bracket.py +17 -24
- scipy/optimize/_chandrupatla.py +9 -10
- scipy/optimize/_cobyla_py.py +104 -123
- scipy/optimize/_constraints.py +14 -10
- scipy/optimize/_differentiable_functions.py +371 -230
- scipy/optimize/_differentialevolution.py +4 -3
- scipy/optimize/_direct.cpython-313t-darwin.so +0 -0
- scipy/optimize/_dual_annealing.py +1 -1
- scipy/optimize/_elementwise.py +1 -4
- scipy/optimize/_group_columns.cpython-313t-darwin.so +0 -0
- scipy/optimize/_lbfgsb.cpython-313t-darwin.so +0 -0
- scipy/optimize/_lbfgsb_py.py +57 -16
- scipy/optimize/_linprog_doc.py +2 -2
- scipy/optimize/_linprog_highs.py +2 -2
- scipy/optimize/_linprog_ip.py +25 -10
- scipy/optimize/_linprog_util.py +14 -16
- scipy/optimize/_lsap.cpython-313t-darwin.so +0 -0
- scipy/optimize/_lsq/common.py +3 -3
- scipy/optimize/_lsq/dogbox.py +16 -2
- scipy/optimize/_lsq/givens_elimination.cpython-313t-darwin.so +0 -0
- scipy/optimize/_lsq/least_squares.py +198 -126
- scipy/optimize/_lsq/lsq_linear.py +6 -6
- scipy/optimize/_lsq/trf.py +35 -8
- scipy/optimize/_milp.py +3 -1
- scipy/optimize/_minimize.py +105 -36
- scipy/optimize/_minpack.cpython-313t-darwin.so +0 -0
- scipy/optimize/_minpack_py.py +21 -14
- scipy/optimize/_moduleTNC.cpython-313t-darwin.so +0 -0
- scipy/optimize/_nnls.py +20 -21
- scipy/optimize/_nonlin.py +34 -3
- scipy/optimize/_numdiff.py +288 -110
- scipy/optimize/_optimize.py +86 -48
- scipy/optimize/_pava_pybind.cpython-313t-darwin.so +0 -0
- scipy/optimize/_remove_redundancy.py +5 -5
- scipy/optimize/_root_scalar.py +1 -1
- scipy/optimize/_shgo.py +6 -0
- scipy/optimize/_shgo_lib/_complex.py +1 -1
- scipy/optimize/_slsqp_py.py +216 -124
- scipy/optimize/_slsqplib.cpython-313t-darwin.so +0 -0
- scipy/optimize/_spectral.py +1 -1
- scipy/optimize/_tnc.py +8 -1
- scipy/optimize/_trlib/_trlib.cpython-313t-darwin.so +0 -0
- scipy/optimize/_trustregion.py +20 -6
- scipy/optimize/_trustregion_constr/canonical_constraint.py +7 -7
- scipy/optimize/_trustregion_constr/equality_constrained_sqp.py +1 -1
- scipy/optimize/_trustregion_constr/minimize_trustregion_constr.py +11 -3
- scipy/optimize/_trustregion_constr/projections.py +12 -8
- scipy/optimize/_trustregion_constr/qp_subproblem.py +9 -9
- scipy/optimize/_trustregion_constr/tests/test_projections.py +7 -7
- scipy/optimize/_trustregion_constr/tests/test_qp_subproblem.py +77 -77
- scipy/optimize/_trustregion_constr/tr_interior_point.py +5 -5
- scipy/optimize/_trustregion_exact.py +0 -1
- scipy/optimize/_zeros.cpython-313t-darwin.so +0 -0
- scipy/optimize/_zeros_py.py +97 -17
- scipy/optimize/cython_optimize/_zeros.cpython-313t-darwin.so +0 -0
- scipy/optimize/slsqp.py +0 -1
- scipy/optimize/tests/test__basinhopping.py +1 -1
- scipy/optimize/tests/test__differential_evolution.py +4 -4
- scipy/optimize/tests/test__linprog_clean_inputs.py +5 -3
- scipy/optimize/tests/test__numdiff.py +66 -22
- scipy/optimize/tests/test__remove_redundancy.py +2 -2
- scipy/optimize/tests/test__shgo.py +9 -1
- scipy/optimize/tests/test_bracket.py +36 -46
- scipy/optimize/tests/test_chandrupatla.py +133 -135
- scipy/optimize/tests/test_cobyla.py +74 -45
- scipy/optimize/tests/test_constraints.py +1 -1
- scipy/optimize/tests/test_differentiable_functions.py +226 -6
- scipy/optimize/tests/test_lbfgsb_hessinv.py +22 -0
- scipy/optimize/tests/test_least_squares.py +125 -13
- scipy/optimize/tests/test_linear_assignment.py +3 -3
- scipy/optimize/tests/test_linprog.py +3 -3
- scipy/optimize/tests/test_lsq_linear.py +6 -6
- scipy/optimize/tests/test_minimize_constrained.py +2 -2
- scipy/optimize/tests/test_minpack.py +4 -4
- scipy/optimize/tests/test_nnls.py +43 -3
- scipy/optimize/tests/test_nonlin.py +36 -0
- scipy/optimize/tests/test_optimize.py +95 -17
- scipy/optimize/tests/test_slsqp.py +36 -4
- scipy/optimize/tests/test_zeros.py +34 -1
- scipy/signal/__init__.py +12 -23
- scipy/signal/_delegators.py +568 -0
- scipy/signal/_filter_design.py +459 -241
- scipy/signal/_fir_filter_design.py +262 -90
- scipy/signal/_lti_conversion.py +3 -2
- scipy/signal/_ltisys.py +118 -91
- scipy/signal/_max_len_seq_inner.cpython-313t-darwin.so +0 -0
- scipy/signal/_peak_finding_utils.cpython-313t-darwin.so +0 -0
- scipy/signal/_polyutils.py +172 -0
- scipy/signal/_short_time_fft.py +519 -70
- scipy/signal/_signal_api.py +30 -0
- scipy/signal/_signaltools.py +719 -399
- scipy/signal/_sigtools.cpython-313t-darwin.so +0 -0
- scipy/signal/_sosfilt.cpython-313t-darwin.so +0 -0
- scipy/signal/_spectral_py.py +230 -50
- scipy/signal/_spline.cpython-313t-darwin.so +0 -0
- scipy/signal/_spline_filters.py +108 -68
- scipy/signal/_support_alternative_backends.py +73 -0
- scipy/signal/_upfirdn.py +4 -1
- scipy/signal/_upfirdn_apply.cpython-313t-darwin.so +0 -0
- scipy/signal/_waveforms.py +2 -11
- scipy/signal/_wavelets.py +1 -1
- scipy/signal/fir_filter_design.py +1 -0
- scipy/signal/spline.py +4 -11
- scipy/signal/tests/_scipy_spectral_test_shim.py +2 -171
- scipy/signal/tests/test_bsplines.py +114 -79
- scipy/signal/tests/test_cont2discrete.py +9 -2
- scipy/signal/tests/test_filter_design.py +721 -481
- scipy/signal/tests/test_fir_filter_design.py +332 -140
- scipy/signal/tests/test_savitzky_golay.py +4 -3
- scipy/signal/tests/test_short_time_fft.py +221 -3
- scipy/signal/tests/test_signaltools.py +2144 -1348
- scipy/signal/tests/test_spectral.py +50 -6
- scipy/signal/tests/test_splines.py +161 -96
- scipy/signal/tests/test_upfirdn.py +84 -50
- scipy/signal/tests/test_waveforms.py +20 -0
- scipy/signal/tests/test_windows.py +607 -466
- scipy/signal/windows/_windows.py +287 -148
- scipy/sparse/__init__.py +23 -4
- scipy/sparse/_base.py +270 -108
- scipy/sparse/_bsr.py +7 -4
- scipy/sparse/_compressed.py +59 -231
- scipy/sparse/_construct.py +90 -38
- scipy/sparse/_coo.py +115 -181
- scipy/sparse/_csc.py +4 -4
- scipy/sparse/_csparsetools.cpython-313t-darwin.so +0 -0
- scipy/sparse/_csr.py +2 -2
- scipy/sparse/_data.py +48 -48
- scipy/sparse/_dia.py +105 -18
- scipy/sparse/_dok.py +0 -23
- scipy/sparse/_index.py +4 -4
- scipy/sparse/_matrix.py +23 -0
- scipy/sparse/_sparsetools.cpython-313t-darwin.so +0 -0
- scipy/sparse/_sputils.py +37 -22
- scipy/sparse/base.py +0 -9
- scipy/sparse/bsr.py +0 -14
- scipy/sparse/compressed.py +0 -23
- scipy/sparse/construct.py +0 -6
- scipy/sparse/coo.py +0 -14
- scipy/sparse/csc.py +0 -3
- scipy/sparse/csgraph/_flow.cpython-313t-darwin.so +0 -0
- scipy/sparse/csgraph/_matching.cpython-313t-darwin.so +0 -0
- scipy/sparse/csgraph/_min_spanning_tree.cpython-313t-darwin.so +0 -0
- scipy/sparse/csgraph/_reordering.cpython-313t-darwin.so +0 -0
- scipy/sparse/csgraph/_shortest_path.cpython-313t-darwin.so +0 -0
- scipy/sparse/csgraph/_tools.cpython-313t-darwin.so +0 -0
- scipy/sparse/csgraph/_traversal.cpython-313t-darwin.so +0 -0
- scipy/sparse/csgraph/tests/test_matching.py +14 -2
- scipy/sparse/csgraph/tests/test_pydata_sparse.py +4 -1
- scipy/sparse/csgraph/tests/test_shortest_path.py +83 -27
- scipy/sparse/csr.py +0 -5
- scipy/sparse/data.py +1 -6
- scipy/sparse/dia.py +0 -7
- scipy/sparse/dok.py +0 -10
- scipy/sparse/linalg/_dsolve/_superlu.cpython-313t-darwin.so +0 -0
- scipy/sparse/linalg/_dsolve/linsolve.py +9 -0
- scipy/sparse/linalg/_dsolve/tests/test_linsolve.py +35 -28
- scipy/sparse/linalg/_eigen/arpack/_arpack.cpython-313t-darwin.so +0 -0
- scipy/sparse/linalg/_eigen/arpack/arpack.py +23 -17
- scipy/sparse/linalg/_eigen/lobpcg/lobpcg.py +6 -6
- scipy/sparse/linalg/_interface.py +17 -18
- scipy/sparse/linalg/_isolve/_gcrotmk.py +4 -4
- scipy/sparse/linalg/_isolve/iterative.py +51 -45
- scipy/sparse/linalg/_isolve/lgmres.py +6 -6
- scipy/sparse/linalg/_isolve/minres.py +5 -5
- scipy/sparse/linalg/_isolve/tfqmr.py +7 -7
- scipy/sparse/linalg/_isolve/utils.py +2 -8
- scipy/sparse/linalg/_matfuncs.py +1 -1
- scipy/sparse/linalg/_norm.py +1 -1
- scipy/sparse/linalg/_propack/_cpropack.cpython-313t-darwin.so +0 -0
- scipy/sparse/linalg/_propack/_dpropack.cpython-313t-darwin.so +0 -0
- scipy/sparse/linalg/_propack/_spropack.cpython-313t-darwin.so +0 -0
- scipy/sparse/linalg/_propack/_zpropack.cpython-313t-darwin.so +0 -0
- scipy/sparse/linalg/_special_sparse_arrays.py +39 -38
- scipy/sparse/linalg/tests/test_pydata_sparse.py +14 -0
- scipy/sparse/tests/test_arithmetic1d.py +5 -2
- scipy/sparse/tests/test_base.py +214 -42
- scipy/sparse/tests/test_common1d.py +7 -7
- scipy/sparse/tests/test_construct.py +1 -1
- scipy/sparse/tests/test_coo.py +272 -4
- scipy/sparse/tests/test_sparsetools.py +5 -0
- scipy/sparse/tests/test_sputils.py +36 -7
- scipy/spatial/_ckdtree.cpython-313t-darwin.so +0 -0
- scipy/spatial/_distance_pybind.cpython-313t-darwin.so +0 -0
- scipy/spatial/_distance_wrap.cpython-313t-darwin.so +0 -0
- scipy/spatial/_hausdorff.cpython-313t-darwin.so +0 -0
- scipy/spatial/_qhull.cpython-313t-darwin.so +0 -0
- scipy/spatial/_voronoi.cpython-313t-darwin.so +0 -0
- scipy/spatial/distance.py +49 -42
- scipy/spatial/tests/test_distance.py +15 -1
- scipy/spatial/tests/test_kdtree.py +1 -0
- scipy/spatial/tests/test_qhull.py +7 -2
- scipy/spatial/transform/__init__.py +5 -3
- scipy/spatial/transform/_rigid_transform.cpython-313t-darwin.so +0 -0
- scipy/spatial/transform/_rotation.cpython-313t-darwin.so +0 -0
- scipy/spatial/transform/tests/test_rigid_transform.py +1221 -0
- scipy/spatial/transform/tests/test_rotation.py +1213 -832
- scipy/spatial/transform/tests/test_rotation_groups.py +3 -3
- scipy/spatial/transform/tests/test_rotation_spline.py +29 -8
- scipy/special/__init__.py +1 -47
- scipy/special/_add_newdocs.py +34 -772
- scipy/special/_basic.py +22 -25
- scipy/special/_comb.cpython-313t-darwin.so +0 -0
- scipy/special/_ellip_harm_2.cpython-313t-darwin.so +0 -0
- scipy/special/_gufuncs.cpython-313t-darwin.so +0 -0
- scipy/special/_logsumexp.py +67 -58
- scipy/special/_orthogonal.pyi +1 -1
- scipy/special/_specfun.cpython-313t-darwin.so +0 -0
- scipy/special/_special_ufuncs.cpython-313t-darwin.so +0 -0
- scipy/special/_spherical_bessel.py +4 -4
- scipy/special/_support_alternative_backends.py +212 -119
- scipy/special/_test_internal.cpython-313t-darwin.so +0 -0
- scipy/special/_testutils.py +4 -4
- scipy/special/_ufuncs.cpython-313t-darwin.so +0 -0
- scipy/special/_ufuncs.pyi +1 -0
- scipy/special/_ufuncs.pyx +215 -1400
- scipy/special/_ufuncs_cxx.cpython-313t-darwin.so +0 -0
- scipy/special/_ufuncs_cxx.pxd +2 -15
- scipy/special/_ufuncs_cxx.pyx +5 -44
- scipy/special/_ufuncs_cxx_defs.h +2 -16
- scipy/special/_ufuncs_defs.h +0 -8
- scipy/special/cython_special.cpython-313t-darwin.so +0 -0
- scipy/special/cython_special.pxd +1 -1
- scipy/special/tests/_cython_examples/meson.build +10 -1
- scipy/special/tests/test_basic.py +153 -20
- scipy/special/tests/test_boost_ufuncs.py +3 -0
- scipy/special/tests/test_cdflib.py +35 -11
- scipy/special/tests/test_gammainc.py +16 -0
- scipy/special/tests/test_hyp2f1.py +2 -2
- scipy/special/tests/test_log1mexp.py +85 -0
- scipy/special/tests/test_logsumexp.py +206 -64
- scipy/special/tests/test_mpmath.py +1 -0
- scipy/special/tests/test_nan_inputs.py +1 -1
- scipy/special/tests/test_orthogonal.py +17 -18
- scipy/special/tests/test_sf_error.py +3 -2
- scipy/special/tests/test_sph_harm.py +6 -7
- scipy/special/tests/test_support_alternative_backends.py +211 -76
- scipy/stats/__init__.py +4 -1
- scipy/stats/_ansari_swilk_statistics.cpython-313t-darwin.so +0 -0
- scipy/stats/_axis_nan_policy.py +5 -12
- scipy/stats/_biasedurn.cpython-313t-darwin.so +0 -0
- scipy/stats/_continued_fraction.py +387 -0
- scipy/stats/_continuous_distns.py +277 -310
- scipy/stats/_correlation.py +1 -1
- scipy/stats/_covariance.py +6 -3
- scipy/stats/_discrete_distns.py +39 -32
- scipy/stats/_distn_infrastructure.py +39 -12
- scipy/stats/_distribution_infrastructure.py +900 -238
- scipy/stats/_entropy.py +9 -10
- scipy/{_lib → stats}/_finite_differences.py +1 -1
- scipy/stats/_hypotests.py +83 -50
- scipy/stats/_kde.py +53 -49
- scipy/stats/_ksstats.py +1 -1
- scipy/stats/_levy_stable/__init__.py +7 -15
- scipy/stats/_levy_stable/levyst.cpython-313t-darwin.so +0 -0
- scipy/stats/_morestats.py +118 -73
- scipy/stats/_mstats_basic.py +13 -17
- scipy/stats/_mstats_extras.py +8 -8
- scipy/stats/_multivariate.py +89 -113
- scipy/stats/_new_distributions.py +97 -20
- scipy/stats/_page_trend_test.py +12 -5
- scipy/stats/_probability_distribution.py +265 -43
- scipy/stats/_qmc.py +14 -9
- scipy/stats/_qmc_cy.cpython-313t-darwin.so +0 -0
- scipy/stats/_qmvnt.py +16 -95
- scipy/stats/_qmvnt_cy.cpython-313t-darwin.so +0 -0
- scipy/stats/_quantile.py +335 -0
- scipy/stats/_rcont/rcont.cpython-313t-darwin.so +0 -0
- scipy/stats/_resampling.py +4 -29
- scipy/stats/_sampling.py +1 -1
- scipy/stats/_sobol.cpython-313t-darwin.so +0 -0
- scipy/stats/_stats.cpython-313t-darwin.so +0 -0
- scipy/stats/_stats_mstats_common.py +21 -2
- scipy/stats/_stats_py.py +550 -476
- scipy/stats/_stats_pythran.cpython-313t-darwin.so +0 -0
- scipy/stats/_unuran/unuran_wrapper.cpython-313t-darwin.so +0 -0
- scipy/stats/_unuran/unuran_wrapper.pyi +2 -1
- scipy/stats/_variation.py +6 -8
- scipy/stats/_wilcoxon.py +13 -7
- scipy/stats/tests/common_tests.py +6 -4
- scipy/stats/tests/test_axis_nan_policy.py +62 -24
- scipy/stats/tests/test_continued_fraction.py +173 -0
- scipy/stats/tests/test_continuous.py +379 -60
- scipy/stats/tests/test_continuous_basic.py +18 -12
- scipy/stats/tests/test_discrete_basic.py +14 -8
- scipy/stats/tests/test_discrete_distns.py +16 -16
- scipy/stats/tests/test_distributions.py +95 -75
- scipy/stats/tests/test_entropy.py +40 -48
- scipy/stats/tests/test_fit.py +4 -3
- scipy/stats/tests/test_hypotests.py +153 -24
- scipy/stats/tests/test_kdeoth.py +109 -41
- scipy/stats/tests/test_marray.py +289 -0
- scipy/stats/tests/test_morestats.py +79 -47
- scipy/stats/tests/test_mstats_basic.py +3 -3
- scipy/stats/tests/test_multivariate.py +434 -83
- scipy/stats/tests/test_qmc.py +13 -10
- scipy/stats/tests/test_quantile.py +199 -0
- scipy/stats/tests/test_rank.py +119 -112
- scipy/stats/tests/test_resampling.py +47 -56
- scipy/stats/tests/test_sampling.py +9 -4
- scipy/stats/tests/test_stats.py +799 -939
- scipy/stats/tests/test_variation.py +8 -6
- scipy/version.py +2 -2
- {scipy-1.15.3.dist-info → scipy-1.16.0rc2.dist-info}/LICENSE.txt +4 -4
- {scipy-1.15.3.dist-info → scipy-1.16.0rc2.dist-info}/METADATA +11 -11
- {scipy-1.15.3.dist-info → scipy-1.16.0rc2.dist-info}/RECORD +559 -566
- scipy-1.16.0rc2.dist-info/WHEEL +6 -0
- scipy/_lib/array_api_extra/_funcs.py +0 -484
- scipy/_lib/array_api_extra/_typing.py +0 -8
- scipy/interpolate/_bspl.cpython-313t-darwin.so +0 -0
- scipy/optimize/_cobyla.cpython-313t-darwin.so +0 -0
- scipy/optimize/_cython_nnls.cpython-313t-darwin.so +0 -0
- scipy/optimize/_slsqp.cpython-313t-darwin.so +0 -0
- scipy/spatial/qhull_src/COPYING.txt +0 -38
- scipy/special/libsf_error_state.dylib +0 -0
- scipy/special/tests/test_log_softmax.py +0 -109
- scipy/special/tests/test_xsf_cuda.py +0 -114
- scipy/special/xsf/binom.h +0 -89
- scipy/special/xsf/cdflib.h +0 -100
- scipy/special/xsf/cephes/airy.h +0 -307
- scipy/special/xsf/cephes/besselpoly.h +0 -51
- scipy/special/xsf/cephes/beta.h +0 -257
- scipy/special/xsf/cephes/cbrt.h +0 -131
- scipy/special/xsf/cephes/chbevl.h +0 -85
- scipy/special/xsf/cephes/chdtr.h +0 -193
- scipy/special/xsf/cephes/const.h +0 -87
- scipy/special/xsf/cephes/ellie.h +0 -293
- scipy/special/xsf/cephes/ellik.h +0 -251
- scipy/special/xsf/cephes/ellpe.h +0 -107
- scipy/special/xsf/cephes/ellpk.h +0 -117
- scipy/special/xsf/cephes/expn.h +0 -260
- scipy/special/xsf/cephes/gamma.h +0 -398
- scipy/special/xsf/cephes/hyp2f1.h +0 -596
- scipy/special/xsf/cephes/hyperg.h +0 -361
- scipy/special/xsf/cephes/i0.h +0 -149
- scipy/special/xsf/cephes/i1.h +0 -158
- scipy/special/xsf/cephes/igam.h +0 -421
- scipy/special/xsf/cephes/igam_asymp_coeff.h +0 -195
- scipy/special/xsf/cephes/igami.h +0 -313
- scipy/special/xsf/cephes/j0.h +0 -225
- scipy/special/xsf/cephes/j1.h +0 -198
- scipy/special/xsf/cephes/jv.h +0 -715
- scipy/special/xsf/cephes/k0.h +0 -164
- scipy/special/xsf/cephes/k1.h +0 -163
- scipy/special/xsf/cephes/kn.h +0 -243
- scipy/special/xsf/cephes/lanczos.h +0 -112
- scipy/special/xsf/cephes/ndtr.h +0 -275
- scipy/special/xsf/cephes/poch.h +0 -85
- scipy/special/xsf/cephes/polevl.h +0 -167
- scipy/special/xsf/cephes/psi.h +0 -194
- scipy/special/xsf/cephes/rgamma.h +0 -111
- scipy/special/xsf/cephes/scipy_iv.h +0 -811
- scipy/special/xsf/cephes/shichi.h +0 -248
- scipy/special/xsf/cephes/sici.h +0 -224
- scipy/special/xsf/cephes/sindg.h +0 -221
- scipy/special/xsf/cephes/tandg.h +0 -139
- scipy/special/xsf/cephes/trig.h +0 -58
- scipy/special/xsf/cephes/unity.h +0 -186
- scipy/special/xsf/cephes/zeta.h +0 -172
- scipy/special/xsf/config.h +0 -304
- scipy/special/xsf/digamma.h +0 -205
- scipy/special/xsf/error.h +0 -57
- scipy/special/xsf/evalpoly.h +0 -47
- scipy/special/xsf/expint.h +0 -266
- scipy/special/xsf/hyp2f1.h +0 -694
- scipy/special/xsf/iv_ratio.h +0 -173
- scipy/special/xsf/lambertw.h +0 -150
- scipy/special/xsf/loggamma.h +0 -163
- scipy/special/xsf/sici.h +0 -200
- scipy/special/xsf/tools.h +0 -427
- scipy/special/xsf/trig.h +0 -164
- scipy/special/xsf/wright_bessel.h +0 -843
- scipy/special/xsf/zlog1.h +0 -35
- scipy/stats/_mvn.cpython-313t-darwin.so +0 -0
- scipy-1.15.3.dist-info/WHEEL +0 -4
@@ -0,0 +1,588 @@
|
|
1
|
+
import inspect
|
2
|
+
import pytest
|
3
|
+
import numpy as np
|
4
|
+
from numpy.testing import assert_allclose
|
5
|
+
from scipy import linalg, sparse
|
6
|
+
|
7
|
+
|
8
|
+
real_floating = [np.float32, np.float64]
|
9
|
+
complex_floating = [np.complex64, np.complex128]
|
10
|
+
floating = real_floating + complex_floating
|
11
|
+
|
12
|
+
|
13
|
+
def get_random(shape, *, dtype, rng):
|
14
|
+
A = rng.random(shape)
|
15
|
+
if np.issubdtype(dtype, np.complexfloating):
|
16
|
+
A = A + rng.random(shape) * 1j
|
17
|
+
return A.astype(dtype)
|
18
|
+
|
19
|
+
def get_nearly_hermitian(shape, dtype, atol, rng):
|
20
|
+
# Generate a batch of nearly Hermitian matrices with specified
|
21
|
+
# `shape` and `dtype`. `atol` controls the level of noise in
|
22
|
+
# Hermitian-ness to by generated by `rng`.
|
23
|
+
A = rng.random(shape).astype(dtype)
|
24
|
+
At = np.conj(A.swapaxes(-1, -2))
|
25
|
+
noise = rng.standard_normal(size=A.shape).astype(dtype) * atol
|
26
|
+
return A + At + noise
|
27
|
+
|
28
|
+
|
29
|
+
class TestBatch:
|
30
|
+
# Test batch support for most linalg functions
|
31
|
+
|
32
|
+
def batch_test(self, fun, arrays, *, core_dim=2, n_out=1, kwargs=None, dtype=None,
|
33
|
+
broadcast=True, check_kwargs=True):
|
34
|
+
# Check that all outputs of batched call `fun(A, **kwargs)` are the same
|
35
|
+
# as if we loop over the separate vectors/matrices in `A`. Also check
|
36
|
+
# that `fun` accepts `A` by position or keyword and that results are
|
37
|
+
# identical. This is important because the name of the array argument
|
38
|
+
# is manually specified to the decorator, and it's easy to mess up.
|
39
|
+
# However, this makes it hard to test positional arguments passed
|
40
|
+
# after the array, so we test that separately for a few functions to
|
41
|
+
# make sure the decorator is working as it should.
|
42
|
+
|
43
|
+
kwargs = {} if kwargs is None else kwargs
|
44
|
+
parameters = list(inspect.signature(fun).parameters.keys())
|
45
|
+
arrays = (arrays,) if not isinstance(arrays, tuple) else arrays
|
46
|
+
|
47
|
+
# Identical results when passing argument by keyword or position
|
48
|
+
res2 = fun(*arrays, **kwargs)
|
49
|
+
if check_kwargs:
|
50
|
+
res1 = fun(**dict(zip(parameters, arrays)), **kwargs)
|
51
|
+
for out1, out2 in zip(res1, res2): # even a single array is iterable...
|
52
|
+
np.testing.assert_equal(out1, out2)
|
53
|
+
|
54
|
+
# Check results vs looping over
|
55
|
+
res = (res2,) if n_out == 1 else res2
|
56
|
+
# This is not the general behavior (only batch dimensions get
|
57
|
+
# broadcasted by the decorator) but it's easier for testing.
|
58
|
+
if broadcast:
|
59
|
+
arrays = np.broadcast_arrays(*arrays)
|
60
|
+
batch_shape = arrays[0].shape[:-core_dim]
|
61
|
+
for i in range(batch_shape[0]):
|
62
|
+
for j in range(batch_shape[1]):
|
63
|
+
arrays_ij = (array[i, j] for array in arrays)
|
64
|
+
ref = fun(*arrays_ij, **kwargs)
|
65
|
+
ref = ((np.asarray(ref),) if n_out == 1 else
|
66
|
+
tuple(np.asarray(refk) for refk in ref))
|
67
|
+
for k in range(n_out):
|
68
|
+
assert_allclose(res[k][i, j], ref[k])
|
69
|
+
assert np.shape(res[k][i, j]) == ref[k].shape
|
70
|
+
|
71
|
+
for k in range(len(ref)):
|
72
|
+
out_dtype = ref[k].dtype if dtype is None else dtype
|
73
|
+
assert res[k].dtype == out_dtype
|
74
|
+
|
75
|
+
return res2 # return original, non-tuplized result
|
76
|
+
|
77
|
+
@pytest.mark.parametrize('dtype', floating)
|
78
|
+
def test_expm_cond(self, dtype):
|
79
|
+
rng = np.random.default_rng(8342310302941288912051)
|
80
|
+
A = rng.random((5, 3, 4, 4)).astype(dtype)
|
81
|
+
self.batch_test(linalg.expm_cond, A)
|
82
|
+
|
83
|
+
@pytest.mark.parametrize('dtype', floating)
|
84
|
+
def test_issymmetric(self, dtype):
|
85
|
+
rng = np.random.default_rng(8342310302941288912051)
|
86
|
+
A = get_nearly_hermitian((5, 3, 4, 4), dtype, 3e-4, rng)
|
87
|
+
res = self.batch_test(linalg.issymmetric, A, kwargs=dict(atol=1e-3))
|
88
|
+
assert not np.all(res) # ensure test is not trivial: not all True or False;
|
89
|
+
assert np.any(res) # also confirms that `atol` is passed to issymmetric
|
90
|
+
|
91
|
+
@pytest.mark.parametrize('dtype', floating)
|
92
|
+
def test_ishermitian(self, dtype):
|
93
|
+
rng = np.random.default_rng(8342310302941288912051)
|
94
|
+
A = get_nearly_hermitian((5, 3, 4, 4), dtype, 3e-4, rng)
|
95
|
+
res = self.batch_test(linalg.ishermitian, A, kwargs=dict(atol=1e-3))
|
96
|
+
assert not np.all(res) # ensure test is not trivial: not all True or False;
|
97
|
+
assert np.any(res) # also confirms that `atol` is passed to ishermitian
|
98
|
+
|
99
|
+
@pytest.mark.parametrize('dtype', floating)
|
100
|
+
def test_diagsvd(self, dtype):
|
101
|
+
rng = np.random.default_rng(8342310302941288912051)
|
102
|
+
A = rng.random((5, 3, 4)).astype(dtype)
|
103
|
+
res1 = self.batch_test(linalg.diagsvd, A, kwargs=dict(M=6, N=4), core_dim=1)
|
104
|
+
# test that `M, N` can be passed by position
|
105
|
+
res2 = linalg.diagsvd(A, 6, 4)
|
106
|
+
np.testing.assert_equal(res1, res2)
|
107
|
+
|
108
|
+
@pytest.mark.parametrize('fun', [linalg.inv, linalg.sqrtm, linalg.signm,
|
109
|
+
linalg.sinm, linalg.cosm, linalg.tanhm,
|
110
|
+
linalg.sinhm, linalg.coshm, linalg.tanhm,
|
111
|
+
linalg.pinv, linalg.pinvh, linalg.orth])
|
112
|
+
@pytest.mark.parametrize('dtype', floating)
|
113
|
+
def test_matmat(self, fun, dtype): # matrix in, matrix out
|
114
|
+
rng = np.random.default_rng(8342310302941288912051)
|
115
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
116
|
+
|
117
|
+
# sqrtm can return complex output for real input resulting in i/o type
|
118
|
+
# mismatch. Nudge the eigenvalues to positive side to avoid this.
|
119
|
+
if fun == linalg.sqrtm:
|
120
|
+
A = A + 3*np.eye(4, dtype=dtype)
|
121
|
+
|
122
|
+
self.batch_test(fun, A)
|
123
|
+
|
124
|
+
@pytest.mark.parametrize('dtype', floating)
|
125
|
+
def test_null_space(self, dtype):
|
126
|
+
rng = np.random.default_rng(8342310302941288912051)
|
127
|
+
A = get_random((5, 3, 4, 6), dtype=dtype, rng=rng)
|
128
|
+
self.batch_test(linalg.null_space, A)
|
129
|
+
|
130
|
+
@pytest.mark.parametrize('dtype', floating)
|
131
|
+
def test_funm(self, dtype):
|
132
|
+
rng = np.random.default_rng(8342310302941288912051)
|
133
|
+
A = get_random((2, 4, 3, 3), dtype=dtype, rng=rng)
|
134
|
+
self.batch_test(linalg.funm, A, kwargs=dict(func=np.sin))
|
135
|
+
|
136
|
+
@pytest.mark.parametrize('dtype', floating)
|
137
|
+
def test_fractional_matrix_power(self, dtype):
|
138
|
+
rng = np.random.default_rng(8342310302941288912051)
|
139
|
+
A = get_random((2, 4, 3, 3), dtype=dtype, rng=rng)
|
140
|
+
res1 = self.batch_test(linalg.fractional_matrix_power, A, kwargs={'t':1.5})
|
141
|
+
# test that `t` can be passed by position
|
142
|
+
res2 = linalg.fractional_matrix_power(A, 1.5)
|
143
|
+
np.testing.assert_equal(res1, res2)
|
144
|
+
|
145
|
+
@pytest.mark.parametrize('dtype', floating)
|
146
|
+
def test_logm(self, dtype):
|
147
|
+
# One test failed absolute tolerance with default random seed
|
148
|
+
rng = np.random.default_rng(89940026998903887141749720079406074936)
|
149
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
150
|
+
A = A + 3*np.eye(4) # avoid complex output for real input
|
151
|
+
res1 = self.batch_test(linalg.logm, A)
|
152
|
+
# test that `disp` can be passed by position
|
153
|
+
res2 = linalg.logm(A)
|
154
|
+
for res1i, res2i in zip(res1, res2):
|
155
|
+
np.testing.assert_equal(res1i, res2i)
|
156
|
+
|
157
|
+
@pytest.mark.parametrize('dtype', floating)
|
158
|
+
def test_pinv(self, dtype):
|
159
|
+
rng = np.random.default_rng(8342310302941288912051)
|
160
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
161
|
+
self.batch_test(linalg.pinv, A, n_out=2, kwargs=dict(return_rank=True))
|
162
|
+
|
163
|
+
@pytest.mark.parametrize('dtype', floating)
|
164
|
+
def test_matrix_balance(self, dtype):
|
165
|
+
rng = np.random.default_rng(8342310302941288912051)
|
166
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
167
|
+
self.batch_test(linalg.matrix_balance, A, n_out=2)
|
168
|
+
self.batch_test(linalg.matrix_balance, A, n_out=2, kwargs={'separate':True})
|
169
|
+
|
170
|
+
@pytest.mark.parametrize('dtype', floating)
|
171
|
+
def test_bandwidth(self, dtype):
|
172
|
+
rng = np.random.default_rng(8342310302941288912051)
|
173
|
+
A = get_random((4, 4), dtype=dtype, rng=rng)
|
174
|
+
A = np.asarray([np.triu(A, k) for k in range(-3, 3)]).reshape((2, 3, 4, 4))
|
175
|
+
self.batch_test(linalg.bandwidth, A, n_out=2)
|
176
|
+
|
177
|
+
@pytest.mark.parametrize('fun_n_out', [(linalg.cholesky, 1), (linalg.ldl, 3),
|
178
|
+
(linalg.cho_factor, 2)])
|
179
|
+
@pytest.mark.parametrize('dtype', floating)
|
180
|
+
def test_ldl_cholesky(self, fun_n_out, dtype):
|
181
|
+
rng = np.random.default_rng(8342310302941288912051)
|
182
|
+
fun, n_out = fun_n_out
|
183
|
+
A = get_nearly_hermitian((5, 3, 4, 4), dtype, 0, rng) # exactly Hermitian
|
184
|
+
A = A + 4*np.eye(4, dtype=dtype) # ensure positive definite for Cholesky
|
185
|
+
self.batch_test(fun, A, n_out=n_out)
|
186
|
+
|
187
|
+
@pytest.mark.parametrize('compute_uv', [False, True])
|
188
|
+
@pytest.mark.parametrize('dtype', floating)
|
189
|
+
def test_svd(self, compute_uv, dtype):
|
190
|
+
rng = np.random.default_rng(8342310302941288912051)
|
191
|
+
A = get_random((5, 3, 2, 4), dtype=dtype, rng=rng)
|
192
|
+
n_out = 3 if compute_uv else 1
|
193
|
+
self.batch_test(linalg.svd, A, n_out=n_out, kwargs=dict(compute_uv=compute_uv))
|
194
|
+
|
195
|
+
@pytest.mark.parametrize('fun', [linalg.polar, linalg.qr, linalg.rq])
|
196
|
+
@pytest.mark.parametrize('dtype', floating)
|
197
|
+
def test_polar_qr_rq(self, fun, dtype):
|
198
|
+
rng = np.random.default_rng(8342310302941288912051)
|
199
|
+
A = get_random((5, 3, 2, 4), dtype=dtype, rng=rng)
|
200
|
+
self.batch_test(fun, A, n_out=2)
|
201
|
+
|
202
|
+
@pytest.mark.parametrize('cdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
203
|
+
@pytest.mark.parametrize('dtype', floating)
|
204
|
+
def test_qr_multiply(self, cdim, dtype):
|
205
|
+
rng = np.random.default_rng(8342310302941288912051)
|
206
|
+
A = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
207
|
+
c = get_random(cdim, dtype=dtype, rng=rng)
|
208
|
+
res = linalg.qr_multiply(A, c, mode='left')
|
209
|
+
q, r = linalg.qr(A)
|
210
|
+
ref = q @ c
|
211
|
+
atol = 1e-6 if dtype in {np.float32, np.complex64} else 1e-12
|
212
|
+
assert_allclose(res[0], ref, atol=atol)
|
213
|
+
assert_allclose(res[1], r, atol=atol)
|
214
|
+
|
215
|
+
@pytest.mark.parametrize('uvdim', [[(5,), (3,)], [(4, 5, 2), (4, 3, 2)]])
|
216
|
+
@pytest.mark.parametrize('dtype', floating)
|
217
|
+
def test_qr_update(self, uvdim, dtype):
|
218
|
+
rng = np.random.default_rng(8342310302941288912051)
|
219
|
+
udim, vdim = uvdim
|
220
|
+
A = get_random((4, 5, 3), dtype=dtype, rng=rng)
|
221
|
+
u = get_random(udim, dtype=dtype, rng=rng)
|
222
|
+
v = get_random(vdim, dtype=dtype, rng=rng)
|
223
|
+
q, r = linalg.qr(A)
|
224
|
+
res = linalg.qr_update(q, r, u, v)
|
225
|
+
for i in range(4):
|
226
|
+
qi, ri = q[i], r[i]
|
227
|
+
ui, vi = (u, v) if u.ndim == 1 else (u[i], v[i])
|
228
|
+
ref_i = linalg.qr_update(qi, ri, ui, vi)
|
229
|
+
assert_allclose(res[0][i], ref_i[0])
|
230
|
+
assert_allclose(res[1][i], ref_i[1])
|
231
|
+
|
232
|
+
@pytest.mark.parametrize('udim', [(5,), (4, 3, 5)])
|
233
|
+
@pytest.mark.parametrize('kdim', [(), (4,)])
|
234
|
+
@pytest.mark.parametrize('dtype', floating)
|
235
|
+
def test_qr_insert(self, udim, kdim, dtype):
|
236
|
+
rng = np.random.default_rng(8342310302941288912051)
|
237
|
+
A = get_random((4, 5, 5), dtype=dtype, rng=rng)
|
238
|
+
u = get_random(udim, dtype=dtype, rng=rng)
|
239
|
+
k = rng.integers(0, 5, size=kdim)
|
240
|
+
q, r = linalg.qr(A)
|
241
|
+
res = linalg.qr_insert(q, r, u, k)
|
242
|
+
for i in range(4):
|
243
|
+
qi, ri = q[i], r[i]
|
244
|
+
ki = k if k.ndim == 0 else k[i]
|
245
|
+
ui = u if u.ndim == 1 else u[i]
|
246
|
+
ref_i = linalg.qr_insert(qi, ri, ui, ki)
|
247
|
+
assert_allclose(res[0][i], ref_i[0])
|
248
|
+
assert_allclose(res[1][i], ref_i[1])
|
249
|
+
|
250
|
+
@pytest.mark.parametrize('kdim', [(), (4,)])
|
251
|
+
@pytest.mark.parametrize('dtype', floating)
|
252
|
+
def test_qr_delete(self, kdim, dtype):
|
253
|
+
rng = np.random.default_rng(8342310302941288912051)
|
254
|
+
A = get_random((4, 5, 5), dtype=dtype, rng=rng)
|
255
|
+
k = rng.integers(0, 4, size=kdim)
|
256
|
+
q, r = linalg.qr(A)
|
257
|
+
res = linalg.qr_delete(q, r, k)
|
258
|
+
for i in range(4):
|
259
|
+
qi, ri = q[i], r[i]
|
260
|
+
ki = k if k.ndim == 0 else k[i]
|
261
|
+
ref_i = linalg.qr_delete(qi, ri, ki)
|
262
|
+
assert_allclose(res[0][i], ref_i[0])
|
263
|
+
assert_allclose(res[1][i], ref_i[1])
|
264
|
+
|
265
|
+
@pytest.mark.parametrize('fun', [linalg.schur, linalg.lu_factor])
|
266
|
+
@pytest.mark.parametrize('dtype', floating)
|
267
|
+
def test_schur_lu(self, fun, dtype):
|
268
|
+
rng = np.random.default_rng(8342310302941288912051)
|
269
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
270
|
+
self.batch_test(fun, A, n_out=2)
|
271
|
+
|
272
|
+
@pytest.mark.parametrize('calc_q', [False, True])
|
273
|
+
@pytest.mark.parametrize('dtype', floating)
|
274
|
+
def test_hessenberg(self, calc_q, dtype):
|
275
|
+
rng = np.random.default_rng(8342310302941288912051)
|
276
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
277
|
+
n_out = 2 if calc_q else 1
|
278
|
+
self.batch_test(linalg.hessenberg, A, n_out=n_out, kwargs=dict(calc_q=calc_q))
|
279
|
+
|
280
|
+
@pytest.mark.parametrize('eigvals_only', [False, True])
|
281
|
+
@pytest.mark.parametrize('dtype', floating)
|
282
|
+
def test_eig_banded(self, eigvals_only, dtype):
|
283
|
+
rng = np.random.default_rng(8342310302941288912051)
|
284
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
285
|
+
n_out = 1 if eigvals_only else 2
|
286
|
+
self.batch_test(linalg.eig_banded, A, n_out=n_out,
|
287
|
+
kwargs=dict(eigvals_only=eigvals_only))
|
288
|
+
|
289
|
+
@pytest.mark.parametrize('dtype', floating)
|
290
|
+
def test_eigvals_banded(self, dtype):
|
291
|
+
rng = np.random.default_rng(8342310302941288912051)
|
292
|
+
A = get_random((5, 3, 4, 4), dtype=dtype, rng=rng)
|
293
|
+
self.batch_test(linalg.eigvals_banded, A)
|
294
|
+
|
295
|
+
@pytest.mark.parametrize('two_in', [False, True])
|
296
|
+
@pytest.mark.parametrize('fun_n_nout', [(linalg.eigh, 1), (linalg.eigh, 2),
|
297
|
+
(linalg.eigvalsh, 1), (linalg.eigvals, 1)])
|
298
|
+
@pytest.mark.parametrize('dtype', floating)
|
299
|
+
def test_eigh(self, two_in, fun_n_nout, dtype):
|
300
|
+
rng = np.random.default_rng(8342310302941288912051)
|
301
|
+
fun, n_out = fun_n_nout
|
302
|
+
A = get_nearly_hermitian((1, 3, 4, 4), dtype, 0, rng) # exactly Hermitian
|
303
|
+
B = get_nearly_hermitian((2, 1, 4, 4), dtype, 0, rng) # exactly Hermitian
|
304
|
+
B = B + 4*np.eye(4).astype(dtype) # needs to be positive definite
|
305
|
+
args = (A, B) if two_in else (A,)
|
306
|
+
kwargs = dict(eigvals_only=True) if (n_out == 1 and fun==linalg.eigh) else {}
|
307
|
+
self.batch_test(fun, args, n_out=n_out, kwargs=kwargs)
|
308
|
+
|
309
|
+
@pytest.mark.parametrize('compute_expm', [False, True])
|
310
|
+
@pytest.mark.parametrize('dtype', floating)
|
311
|
+
def test_expm_frechet(self, compute_expm, dtype):
|
312
|
+
rng = np.random.default_rng(8342310302941288912051)
|
313
|
+
A = get_random((1, 3, 4, 4), dtype=dtype, rng=rng)
|
314
|
+
E = get_random((2, 1, 4, 4), dtype=dtype, rng=rng)
|
315
|
+
n_out = 2 if compute_expm else 1
|
316
|
+
self.batch_test(linalg.expm_frechet, (A, E), n_out=n_out,
|
317
|
+
kwargs=dict(compute_expm=compute_expm))
|
318
|
+
|
319
|
+
@pytest.mark.parametrize('dtype', floating)
|
320
|
+
def test_subspace_angles(self, dtype):
|
321
|
+
rng = np.random.default_rng(8342310302941288912051)
|
322
|
+
A = get_random((1, 3, 4, 3), dtype=dtype, rng=rng)
|
323
|
+
B = get_random((2, 1, 4, 3), dtype=dtype, rng=rng)
|
324
|
+
self.batch_test(linalg.subspace_angles, (A, B))
|
325
|
+
# just to show that A and B don't need to be broadcastable
|
326
|
+
M, N, K = 4, 5, 3
|
327
|
+
A = get_random((1, 3, M, N), dtype=dtype, rng=rng)
|
328
|
+
B = get_random((2, 1, M, K), dtype=dtype, rng=rng)
|
329
|
+
assert linalg.subspace_angles(A, B).shape == (2, 3, min(N, K))
|
330
|
+
|
331
|
+
@pytest.mark.parametrize('fun', [linalg.svdvals])
|
332
|
+
@pytest.mark.parametrize('dtype', floating)
|
333
|
+
def test_svdvals(self, fun, dtype):
|
334
|
+
rng = np.random.default_rng(8342310302941288912051)
|
335
|
+
A = get_random((2, 3, 4, 5), dtype=dtype, rng=rng)
|
336
|
+
self.batch_test(fun, A)
|
337
|
+
|
338
|
+
@pytest.mark.parametrize('fun_n_out', [(linalg.orthogonal_procrustes, 2),
|
339
|
+
(linalg.khatri_rao, 1),
|
340
|
+
(linalg.solve_continuous_lyapunov, 1),
|
341
|
+
(linalg.solve_discrete_lyapunov, 1),
|
342
|
+
(linalg.qz, 4),
|
343
|
+
(linalg.ordqz, 6)])
|
344
|
+
@pytest.mark.parametrize('dtype', floating)
|
345
|
+
def test_two_generic_matrix_inputs(self, fun_n_out, dtype):
|
346
|
+
rng = np.random.default_rng(8342310302941288912051)
|
347
|
+
fun, n_out = fun_n_out
|
348
|
+
A = get_random((2, 3, 4, 4), dtype=dtype, rng=rng)
|
349
|
+
B = get_random((2, 3, 4, 4), dtype=dtype, rng=rng)
|
350
|
+
self.batch_test(fun, (A, B), n_out=n_out)
|
351
|
+
|
352
|
+
@pytest.mark.parametrize('dtype', floating)
|
353
|
+
def test_cossin(self, dtype):
|
354
|
+
rng = np.random.default_rng(8342310302941288912051)
|
355
|
+
p, q = 3, 4
|
356
|
+
X = get_random((2, 3, 10, 10), dtype=dtype, rng=rng)
|
357
|
+
x11, x12, x21, x22 = (X[..., :p, :q], X[..., :p, q:],
|
358
|
+
X[..., p:, :q], X[..., p:, q:])
|
359
|
+
res = linalg.cossin(X, p, q)
|
360
|
+
ref = linalg.cossin((x11, x12, x21, x22))
|
361
|
+
for res_i, ref_i in zip(res, ref):
|
362
|
+
np.testing.assert_equal(res_i, ref_i)
|
363
|
+
|
364
|
+
for j in range(2):
|
365
|
+
for k in range(3):
|
366
|
+
ref_jk = linalg.cossin(X[j, k], p, q)
|
367
|
+
for res_i, ref_ijk in zip(res, ref_jk):
|
368
|
+
np.testing.assert_equal(res_i[j, k], ref_ijk)
|
369
|
+
|
370
|
+
@pytest.mark.parametrize('dtype', floating)
|
371
|
+
def test_sylvester(self, dtype):
|
372
|
+
rng = np.random.default_rng(8342310302941288912051)
|
373
|
+
A = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
374
|
+
B = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
375
|
+
C = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
376
|
+
self.batch_test(linalg.solve_sylvester, (A, B, C))
|
377
|
+
|
378
|
+
@pytest.mark.parametrize('fun', [linalg.solve_continuous_are,
|
379
|
+
linalg.solve_discrete_are])
|
380
|
+
@pytest.mark.parametrize('dtype', floating)
|
381
|
+
def test_are(self, fun, dtype):
|
382
|
+
rng = np.random.default_rng(8342310302941288912051)
|
383
|
+
a = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
384
|
+
b = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
385
|
+
q = get_nearly_hermitian((2, 3, 5, 5), dtype=dtype, atol=0, rng=rng)
|
386
|
+
r = get_nearly_hermitian((2, 3, 5, 5), dtype=dtype, atol=0, rng=rng)
|
387
|
+
a = a + 5*np.eye(5) # making these positive definite seems to help
|
388
|
+
b = b + 5*np.eye(5)
|
389
|
+
q = q + 5*np.eye(5)
|
390
|
+
r = r + 5*np.eye(5)
|
391
|
+
# can't easily generate valid random e, s
|
392
|
+
self.batch_test(fun, (a, b, q, r))
|
393
|
+
|
394
|
+
@pytest.mark.parametrize('dtype', floating)
|
395
|
+
def test_rsf2cs(self, dtype):
|
396
|
+
rng = np.random.default_rng(8342310302941288912051)
|
397
|
+
A = get_random((2, 3, 4, 4), dtype=dtype, rng=rng)
|
398
|
+
T, Z = linalg.schur(A)
|
399
|
+
self.batch_test(linalg.rsf2csf, (T, Z), n_out=2)
|
400
|
+
|
401
|
+
@pytest.mark.parametrize('dtype', floating)
|
402
|
+
def test_cholesky_banded(self, dtype):
|
403
|
+
rng = np.random.default_rng(8342310302941288912051)
|
404
|
+
ab = get_random((5, 4, 3, 6), dtype=dtype, rng=rng)
|
405
|
+
ab[..., -1, :] = 10 # make diagonal dominant
|
406
|
+
self.batch_test(linalg.cholesky_banded, ab)
|
407
|
+
|
408
|
+
@pytest.mark.parametrize('dtype', floating)
|
409
|
+
def test_block_diag(self, dtype):
|
410
|
+
rng = np.random.default_rng(8342310302941288912051)
|
411
|
+
a = get_random((1, 3, 1, 3), dtype=dtype, rng=rng)
|
412
|
+
b = get_random((2, 1, 3, 6), dtype=dtype, rng=rng)
|
413
|
+
c = get_random((1, 1, 3, 2), dtype=dtype, rng=rng)
|
414
|
+
|
415
|
+
# batch_test doesn't have the logic to broadcast just the batch shapes,
|
416
|
+
# so do it manually.
|
417
|
+
a2 = np.broadcast_to(a, (2, 3, 1, 3))
|
418
|
+
b2 = np.broadcast_to(b, (2, 3, 3, 6))
|
419
|
+
c2 = np.broadcast_to(c, (2, 3, 3, 2))
|
420
|
+
ref = self.batch_test(linalg.block_diag, (a2, b2, c2),
|
421
|
+
check_kwargs=False, broadcast=False)
|
422
|
+
|
423
|
+
# Check that `block_diag` broadcasts the batch shapes as expected.
|
424
|
+
res = linalg.block_diag(a, b, c)
|
425
|
+
assert_allclose(res, ref)
|
426
|
+
|
427
|
+
@pytest.mark.parametrize('fun_n_out', [(linalg.eigh_tridiagonal, 2),
|
428
|
+
(linalg.eigvalsh_tridiagonal, 1)])
|
429
|
+
@pytest.mark.parametrize('dtype', real_floating)
|
430
|
+
# "Only real arrays currently supported"
|
431
|
+
def test_eigh_tridiagonal(self, fun_n_out, dtype):
|
432
|
+
rng = np.random.default_rng(8342310302941288912051)
|
433
|
+
fun, n_out = fun_n_out
|
434
|
+
d = get_random((3, 4, 5), dtype=dtype, rng=rng)
|
435
|
+
e = get_random((3, 4, 4), dtype=dtype, rng=rng)
|
436
|
+
self.batch_test(fun, (d, e), core_dim=1, n_out=n_out, broadcast=False)
|
437
|
+
|
438
|
+
@pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
439
|
+
@pytest.mark.parametrize('dtype', floating)
|
440
|
+
def test_solve(self, bdim, dtype):
|
441
|
+
rng = np.random.default_rng(8342310302941288912051)
|
442
|
+
A = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
443
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
444
|
+
x = linalg.solve(A, b)
|
445
|
+
if len(bdim) == 1:
|
446
|
+
x = x[..., np.newaxis]
|
447
|
+
b = b[..., np.newaxis]
|
448
|
+
assert_allclose(A @ x - b, 0, atol=1.5e-6)
|
449
|
+
assert_allclose(x, np.linalg.solve(A, b), atol=3e-6)
|
450
|
+
|
451
|
+
@pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
452
|
+
@pytest.mark.parametrize('dtype', floating)
|
453
|
+
def test_lu_solve(self, bdim, dtype):
|
454
|
+
rng = np.random.default_rng(8342310302941288912051)
|
455
|
+
A = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
456
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
457
|
+
lu_and_piv = linalg.lu_factor(A)
|
458
|
+
x = linalg.lu_solve(lu_and_piv, b)
|
459
|
+
if len(bdim) == 1:
|
460
|
+
x = x[..., np.newaxis]
|
461
|
+
b = b[..., np.newaxis]
|
462
|
+
assert_allclose(A @ x - b, 0, atol=1.5e-6)
|
463
|
+
assert_allclose(x, np.linalg.solve(A, b), atol=3e-6)
|
464
|
+
|
465
|
+
@pytest.mark.parametrize('l_and_u', [(1, 1), ([2, 1, 0], [0, 1 , 2])])
|
466
|
+
@pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
467
|
+
@pytest.mark.parametrize('dtype', floating)
|
468
|
+
def test_solve_banded(self, l_and_u, bdim, dtype):
|
469
|
+
rng = np.random.default_rng(8342310302941288912051)
|
470
|
+
l, u = l_and_u
|
471
|
+
ab = get_random((2, 3, 3, 5), dtype=dtype, rng=rng)
|
472
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
473
|
+
x = linalg.solve_banded((l, u), ab, b)
|
474
|
+
for i in range(2):
|
475
|
+
for j in range(3):
|
476
|
+
bij = b if len(bdim) <= 2 else b[i, j]
|
477
|
+
lj = l if np.ndim(l) == 0 else l[j]
|
478
|
+
uj = u if np.ndim(u) == 0 else u[j]
|
479
|
+
xij = linalg.solve_banded((lj, uj), ab[i, j], bij)
|
480
|
+
assert_allclose(x[i, j], xij)
|
481
|
+
|
482
|
+
# Can uncomment when `solve_toeplitz` deprecation is done (SciPy 1.17)
|
483
|
+
# @pytest.mark.parametrize('separate_r', [False, True])
|
484
|
+
# @pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
485
|
+
# @pytest.mark.parametrize('dtype', floating)
|
486
|
+
# def test_solve_toeplitz(self, separate_r, bdim, dtype):
|
487
|
+
# rng = np.random.default_rng(8342310302941288912051)
|
488
|
+
# c = get_random((2, 3, 5), dtype=dtype, rng=rng)
|
489
|
+
# r = get_random((2, 3, 5), dtype=dtype, rng=rng)
|
490
|
+
# c_or_cr = (c, r) if separate_r else c
|
491
|
+
# b = get_random(bdim, dtype=dtype, rng=rng)
|
492
|
+
# x = linalg.solve_toeplitz(c_or_cr, b)
|
493
|
+
# for i in range(2):
|
494
|
+
# for j in range(3):
|
495
|
+
# bij = b if len(bdim) <= 2 else b[i, j]
|
496
|
+
# c_or_cr_ij = (c[i, j], r[i, j]) if separate_r else c[i, j]
|
497
|
+
# xij = linalg.solve_toeplitz(c_or_cr_ij, bij)
|
498
|
+
# assert_allclose(x[i, j], xij)
|
499
|
+
|
500
|
+
@pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
501
|
+
@pytest.mark.parametrize('dtype', floating)
|
502
|
+
def test_cho_solve(self, bdim, dtype):
|
503
|
+
rng = np.random.default_rng(8342310302941288912051)
|
504
|
+
A = get_nearly_hermitian((2, 3, 5, 5), dtype=dtype, atol=0, rng=rng)
|
505
|
+
A = A + 5*np.eye(5)
|
506
|
+
c_and_lower = linalg.cho_factor(A)
|
507
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
508
|
+
x = linalg.cho_solve(c_and_lower, b)
|
509
|
+
if len(bdim) == 1:
|
510
|
+
x = x[..., np.newaxis]
|
511
|
+
b = b[..., np.newaxis]
|
512
|
+
assert_allclose(A @ x - b, 0, atol=1e-6)
|
513
|
+
assert_allclose(x, np.linalg.solve(A, b), atol=2e-6)
|
514
|
+
|
515
|
+
@pytest.mark.parametrize('lower', [False, True])
|
516
|
+
@pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
517
|
+
@pytest.mark.parametrize('dtype', floating)
|
518
|
+
def test_cho_solve_banded(self, lower, bdim, dtype):
|
519
|
+
rng = np.random.default_rng(8342310302941288912051)
|
520
|
+
A = get_random((2, 3, 3, 5), dtype=dtype, rng=rng)
|
521
|
+
row_diag = 0 if lower else -1
|
522
|
+
A[:, :, row_diag] = 10
|
523
|
+
cb = linalg.cholesky_banded(A, lower=lower)
|
524
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
525
|
+
x = linalg.cho_solve_banded((cb, lower), b)
|
526
|
+
for i in range(2):
|
527
|
+
for j in range(3):
|
528
|
+
bij = b if len(bdim) <= 2 else b[i, j]
|
529
|
+
xij = linalg.cho_solve_banded((cb[i, j], lower), bij)
|
530
|
+
assert_allclose(x[i, j], xij)
|
531
|
+
|
532
|
+
@pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
533
|
+
@pytest.mark.parametrize('dtype', floating)
|
534
|
+
def test_solveh_banded(self, bdim, dtype):
|
535
|
+
rng = np.random.default_rng(8342310302941288912051)
|
536
|
+
A = get_random((2, 3, 3, 5), dtype=dtype, rng=rng)
|
537
|
+
A[:, :, -1] = 10
|
538
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
539
|
+
x = linalg.solveh_banded(A, b)
|
540
|
+
for i in range(2):
|
541
|
+
for j in range(3):
|
542
|
+
bij = b if len(bdim) <= 2 else b[i, j]
|
543
|
+
xij = linalg.solveh_banded(A[i, j], bij)
|
544
|
+
assert_allclose(x[i, j], xij)
|
545
|
+
|
546
|
+
@pytest.mark.parametrize('bdim', [(5,), (5, 4), (2, 3, 5, 4)])
|
547
|
+
@pytest.mark.parametrize('dtype', floating)
|
548
|
+
def test_solve_triangular(self, bdim, dtype):
|
549
|
+
rng = np.random.default_rng(8342310302941288912051)
|
550
|
+
A = get_random((2, 3, 5, 5), dtype=dtype, rng=rng)
|
551
|
+
A = np.tril(A)
|
552
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
553
|
+
x = linalg.solve_triangular(A, b, lower=True)
|
554
|
+
if len(bdim) == 1:
|
555
|
+
x = x[..., np.newaxis]
|
556
|
+
b = b[..., np.newaxis]
|
557
|
+
atol = 1e-10 if dtype in (np.complex128, np.float64) else 2e-4
|
558
|
+
assert_allclose(A @ x - b, 0, atol=atol)
|
559
|
+
assert_allclose(x, np.linalg.solve(A, b), atol=5*atol)
|
560
|
+
|
561
|
+
@pytest.mark.parametrize('bdim', [(4,), (4, 3), (2, 3, 4, 3)])
|
562
|
+
@pytest.mark.parametrize('dtype', floating)
|
563
|
+
def test_lstsq(self, bdim, dtype):
|
564
|
+
rng = np.random.default_rng(8342310302941288912051)
|
565
|
+
A = get_random((2, 3, 4, 5), dtype=dtype, rng=rng)
|
566
|
+
b = get_random(bdim, dtype=dtype, rng=rng)
|
567
|
+
res = linalg.lstsq(A, b)
|
568
|
+
x = res[0]
|
569
|
+
if len(bdim) == 1:
|
570
|
+
x = x[..., np.newaxis]
|
571
|
+
b = b[..., np.newaxis]
|
572
|
+
assert_allclose(A @ x - b, 0, atol=2e-6)
|
573
|
+
assert len(res) == 4
|
574
|
+
|
575
|
+
@pytest.mark.parametrize('dtype', floating)
|
576
|
+
def test_clarkson_woodruff_transform(self, dtype):
|
577
|
+
rng = np.random.default_rng(8342310302941288912051)
|
578
|
+
A = get_random((5, 3, 4, 6), dtype=dtype, rng=rng)
|
579
|
+
self.batch_test(linalg.clarkson_woodruff_transform, A,
|
580
|
+
kwargs=dict(sketch_size=3, rng=311224))
|
581
|
+
|
582
|
+
def test_clarkson_woodruff_transform_sparse(self):
|
583
|
+
rng = np.random.default_rng(8342310302941288912051)
|
584
|
+
A = get_random((5, 3, 4, 6), dtype=np.float64, rng=rng)
|
585
|
+
A = sparse.coo_array(A)
|
586
|
+
message = "Batch support for sparse arrays is not available."
|
587
|
+
with pytest.raises(NotImplementedError, match=message):
|
588
|
+
linalg.clarkson_woodruff_transform(A, sketch_size=3, rng=rng)
|
@@ -19,8 +19,6 @@ def test_bandwidth_dtypes():
|
|
19
19
|
def test_bandwidth_non2d_input():
|
20
20
|
A = np.array([1, 2, 3])
|
21
21
|
raises(ValueError, bandwidth, A)
|
22
|
-
A = np.array([[[1, 2, 3], [4, 5, 6]]])
|
23
|
-
raises(ValueError, bandwidth, A)
|
24
22
|
|
25
23
|
|
26
24
|
@pytest.mark.parametrize('T', [x for x in np.typecodes['All']
|
@@ -404,6 +404,36 @@ class TestEig:
|
|
404
404
|
assert vr.shape == (0, 0)
|
405
405
|
assert vr.dtype == vr_n.dtype
|
406
406
|
|
407
|
+
@pytest.mark.parametrize("include_B", [False, True])
|
408
|
+
@pytest.mark.parametrize("left", [False, True])
|
409
|
+
@pytest.mark.parametrize("right", [False, True])
|
410
|
+
@pytest.mark.parametrize("homogeneous_eigvals", [False, True])
|
411
|
+
@pytest.mark.parametrize("dtype", [np.float32, np.complex128])
|
412
|
+
def test_nd_input(self, include_B, left, right, homogeneous_eigvals, dtype):
|
413
|
+
batch_shape = (3, 2)
|
414
|
+
core_shape = (4, 4)
|
415
|
+
rng = np.random.default_rng(3249823598235)
|
416
|
+
A = rng.random(batch_shape + core_shape).astype(dtype)
|
417
|
+
B = rng.random(batch_shape + core_shape).astype(dtype)
|
418
|
+
kwargs = dict(right=right, homogeneous_eigvals=homogeneous_eigvals)
|
419
|
+
|
420
|
+
if include_B:
|
421
|
+
res = eig(A, b=B, left=left, **kwargs)
|
422
|
+
else:
|
423
|
+
res = eig(A, left=left, **kwargs)
|
424
|
+
|
425
|
+
for i in range(batch_shape[0]):
|
426
|
+
for j in range(batch_shape[1]):
|
427
|
+
if include_B:
|
428
|
+
ref = eig(A[i, j], b=B[i, j], left=left, **kwargs)
|
429
|
+
else:
|
430
|
+
ref = eig(A[i, j], left=left, **kwargs)
|
431
|
+
|
432
|
+
if left or right:
|
433
|
+
for k in range(len(ref)):
|
434
|
+
assert_allclose(res[k][i, j], ref[k])
|
435
|
+
else:
|
436
|
+
assert_allclose(res[i, j], ref)
|
407
437
|
|
408
438
|
|
409
439
|
class TestEigBanded:
|
@@ -739,11 +769,11 @@ class TestEigTridiagonal:
|
|
739
769
|
def test_eigvalsh_tridiagonal(self):
|
740
770
|
"""Compare eigenvalues of eigvalsh_tridiagonal with those of eig."""
|
741
771
|
# can't use ?STERF with subselection
|
742
|
-
for driver in ('sterf', 'stev', 'stebz', 'stemr', 'auto'):
|
772
|
+
for driver in ('sterf', 'stev', 'stevd', 'stebz', 'stemr', 'auto'):
|
743
773
|
w = eigvalsh_tridiagonal(self.d, self.e, lapack_driver=driver)
|
744
774
|
assert_array_almost_equal(sort(w), self.w)
|
745
775
|
|
746
|
-
for driver in ('sterf', 'stev'):
|
776
|
+
for driver in ('sterf', 'stev', 'stevd'):
|
747
777
|
assert_raises(ValueError, eigvalsh_tridiagonal, self.d, self.e,
|
748
778
|
lapack_driver=driver, select='i',
|
749
779
|
select_range=(0, 1))
|
@@ -776,7 +806,7 @@ class TestEigTridiagonal:
|
|
776
806
|
# can't use ?STERF when eigenvectors are requested
|
777
807
|
assert_raises(ValueError, eigh_tridiagonal, self.d, self.e,
|
778
808
|
lapack_driver='sterf')
|
779
|
-
for driver in ('stebz', 'stev', 'stemr', 'auto'):
|
809
|
+
for driver in ('stebz', 'stev', 'stevd', 'stemr', 'auto'):
|
780
810
|
w, evec = eigh_tridiagonal(self.d, self.e, lapack_driver=driver)
|
781
811
|
evec_ = evec[:, argsort(w)]
|
782
812
|
assert_array_almost_equal(sort(w), self.w)
|
@@ -1194,6 +1224,13 @@ def test_svd_gesdd_nofegfault():
|
|
1194
1224
|
svd(df)
|
1195
1225
|
|
1196
1226
|
|
1227
|
+
def test_gesdd_nan_error_message():
|
1228
|
+
A = np.eye(2)
|
1229
|
+
A[0, 0] = np.nan
|
1230
|
+
with pytest.raises(ValueError, match="NaN"):
|
1231
|
+
svd(A, check_finite=False)
|
1232
|
+
|
1233
|
+
|
1197
1234
|
class TestSVDVals:
|
1198
1235
|
|
1199
1236
|
@pytest.mark.parametrize('dt', [int, float, np.float32, complex, np.complex64])
|