Updated 2021-01-28 04:11:09 UTC
Updated PRs (new commits but old needs-work label) [34]
- gh-13441: ENH: add functionality `barnard_exact` test to scipy.stats.
- gh-13433: Removed array from 2-sided binomtest and made computation O(logn) from O(n)
- gh-13415: ENH: Support direct constructor for lil_matrix
- gh-13370: ENH: fix ARGUS distribution for small parameters in stats
- gh-13330: ENH: stats: add noncentral hypergeometric distributions (Fisher's and Wallenius')
- gh-13298: Generalized Hyperbolic Distribution
- gh-13223: ENH: stats: add `nan_policy' argument for `stats.wilcoxon`
- gh-13106: DOC: optimize: remove inadvertent block quote indentation
- gh-13050: ENH: add remove method to scipy.spatial.cKDTree
- gh-13048: ENH: stats: Add a function that computes the relative risk.
- gh-13016: ENH: optimize: Nelder-Mead: allow passing initial simplex as x0 & add adaptive parameter to fmin
- gh-12916: ENH: enable stats.shapiro() to take n-dimension input, handle nan and assign axis
- gh-12873: ENH: Stats: add Alexander Govern Test
- gh-12866: ENH, MAINT: Implementation of MINRES (Trac #12861, #885 )
- gh-12755: ENH Adding AUTOSOL file with a package of robust linear equation solvers which detect and handle ill-conditioniong
- gh-12580: add log trick to roots_jacobi an roots_jacobi_sh
- gh-12438: BUG: use ellipkm1 in elliptical filter design to prevent numerical issues
- gh-12197: BUG: fix moments method to support arrays and list
- gh-12184: ENH: Avoid re-factorizing covariance matrix in multivariate_normal_frozen
- gh-11911: ENH: Added bounds to boxcox and boxcox_normmax
- gh-11899: Added sparse nonzero functionality to min, max, argmin, argmax
- gh-11788: MAINT: fix domain edge error for betainc a or b ==0 case is 1.
- gh-11658: WIP, TST, CI: use OpenBLAS for Travis CI Linux
- gh-10598: ENH: added centre and contains feature
- gh-10561: ENH: add poisson two sample test (E-test) to scipy.stats
- gh-10237: [ENH] Coloured signal generation + calculation
- gh-10215: WIP, TST: add compiled cov to Azure CI reports
- gh-9958: Remerge gh-9619: "FIX: Sparse matrix addition/subtraction eliminates explicit zeros"
- gh-8902: EHN: add nanmin/nanmax in scipy.sparse
- gh-8548: BUG: Fix ellipj when m is near 1.0 (#8480)
- gh-7157: ENH: Add polynomial features and extra basis functions to scipy.interpolate.rbf
- gh-5411: WIP: sparse: Sparse bitwise operations (was #3941)
- gh-4747: Implemented Kaiser-Bessel derived window
- gh-4607: WIP: add Chirp Z-transform, zoom FFT
Needs review [158]
- gh-13448: ENH: Add annotations for `scipy.spatial.distance`
- gh-13447: DEV: Update development Docker image
- gh-13445: DOC: fix runtests guidelines.
- gh-13444: Fix johnsonsu doc
- gh-13442: Changed an error to warning for failure to optimise parameters in curve fit
- gh-13438: ENH: wilcoxon exact calculation for n>25
- gh-13436: ENH: interpolate: add input validation to check input x-y is strictly increasing for fitpack.bispev and fitpack.parder
- gh-13434: DOC: stats: note relationship between scaled-inv-chi2 and invgamma
- gh-13431: ENH: stats: override _rvs for nhypergeom
- gh-13425: BUG: spatial: make Rotation picklable
- gh-13423: DOC: Update example for leaf_label_func/dendrogram
- gh-13419: BUG: Fix group delay singularity check
- gh-13418: BUG: Fix moment returning inconsistent types and shapes
- gh-13411: BUG: fix out-of-bound evaluations in optimize.minimize, powell method
- gh-13397: MAINT:linalg: Fix tgsen family wrapper and ordqz
- gh-13396: BUG: Fix MLE for Nakagami `nakagami_gen.fit`
- gh-13392: MAINT: streamlined kwargs for minimizer in dual_annealing
- gh-13389: DOC: Fix deprecated directive syntax
- gh-13381: DOC: update MacOS quickstart with conda-forge compiler, make more similar to ubuntu
- gh-13379: BUG: sparse: fix verbosity in sparse lsqr
- gh-13373: BUG: io/matlab: preserve dimensions of empty >=2D arrays
- gh-13371: ENH: stats: add `bootstrap_ci` for estimating confidence intervals of n-sample statistics
- gh-13367: BUG: stats: Improve cdf and sf calculation for the hypergeom distribution
- gh-13354: BUG: optimize: rename private functions to include leading underscore
- gh-13349: BUG: stats: Reformulate loggamma._rvs to handle c << 1.
- gh-13347: CI: bump gcc from 4.8 to 5.x
- gh-13338: ENH: stats: Implement _sf and _isf for norminvgauss.
- gh-13328: ENH: Boost stats distributions
- gh-13322: Bug: setting iprint=0 hides all output from fmin_l_bfgs_b, but it should print convergence info from final iteration.
- gh-13319: ENH: stats: add fast numerical inversion of distribution CDF
- gh-13312: ENH: stats: vectorize and add nan_policy to hypothesis tests with decorator
- gh-13305: @pradhyumna85 hotfix to solve ValueError("Data must be 1-dimensional.") in boxcox, in case of non array input x and some lambda.
- gh-13295: BUG: stats: fix the support method to return correct bounds
- gh-13292: DOC: stats: note another common parameterization of nbinom
- gh-13282: ENH: added arithmetic operations methods for lti class in ltisys.py
- gh-13271: Fix: Negative zero handling with ifort
- gh-13270: CI: use OpenBLAS 0.3.13
- gh-13265: ENH: Kstest exact performance improvements
- gh-13263: ENH: add Cramer-von Mises test for two samples
- gh-13235: Force LTI state-space matrices to have inexact type
- gh-13231: BUG: stats: improve numerical stability of covariance matrix to fix gh-10205
- gh-13229: ENH: modernise some Fortran code, needed for nagfor compiler
- gh-13215: ENH: stats: add `nan_policy' argument for `stats.rankdata`
- gh-13204: ENH: stats: add Zipfian (different from Zipf/zeta) distribution
- gh-13197: ENH/MAINT: HiGHS upstream enhancements and bug fixes
- gh-13188: DOC: stats: make null and alternative hypotheses of kstest more precise
- gh-13176: ENH: stats: Implement _sf and _isf for the beta distribution.
- gh-13165: BUG, DOC: signal: fix missing doc link, missing window functions, wrong needed arg info, and argument passing issue for get_window()
- gh-13143: MAINT: deal with cases in `minimize` for `(bounds.lb == bounds.ub).any() (third alternate for #12889)
- gh-13103: DOC: scipy.stats: fix documentation issues of multivariate distributions
- gh-13084: ENH: fast Hankel transform
- gh-13075: BUG: fix signal.dlsim for complex input
- gh-13068: ENH: add functionality to scipy.integrate._ivp.Radau
- gh-13066: BUG: fix optimize.dual_annealing does not pass arguments to jacobian
- gh-13040: BUG: Allow RectSphereBivariateSpline to accept negative longitude
- gh-13034: ENH: Allow QAP to accept adjacency matrices of different sizes
- gh-12888: DOC: misc: add note to derivative per gh-12887
- gh-12821: DEV: Add "Particle Swarm Optimization" algorithm to SciPy.optimization
- gh-12806: Added `rcond` keyword to lsq_linear
- gh-12787: ENH: add anderson darling test for weibull #10829
- gh-12781: root_scalar: a new method that improves upon the Newton's method
- gh-12764: ENH: Added scipy.signal.tfest for transfer function estimation
- gh-12760: BUG: special: erfinv(x<<1) loses precision
- gh-12735: ENH: Add support for μ-law encoded PCM to scipy.io.wavfile. This implementation decodes to 16-bit PCM.
- gh-12723: ENH: Create 2DTransfrom.py
- gh-12680: ENH: added non-parametric confidence intervals for quantiles into scipy.stats
- gh-12679: MAINT: Consistently mark BLAS/LAPACK routines as threadsafe
- gh-12676: BUG: update median averaging in signal.csd
- gh-12653: ENH: stats: add Somers' D test
- gh-12641: [WIP] ENH: Add scipy.special.logiv and logive
- gh-12609: ENH: stats: Add 'alternative' and confidence interval to pearsonr.
- gh-12594: BUG: fixed indexing error when using bounds in Powell's method (scipy.optimize.minimize)
- gh-12516: MRG, MAINT: Allow spaces around array-like
- gh-12510: ENH: modularize presolve in linprog #11691
- gh-12473: BUG: fix_integer_overflow_check in _fitpackmodule.c
- gh-12472: ENH: shortcut for positive definite matrices in SciPy.linalg.logm
- gh-12328: improve the accuracy of integrate.simps
- gh-12312: ENH: Accelerate matrix normal sampling using matmul
- gh-12307: Disable FFT cache
- gh-12303: BUG: fmin_powell return for size 1 array
- gh-12260: DOC: Allow for parallel sphinx doc build
- gh-12225: BUG: boxcox data constancy check #5112 #10978
- gh-12211: DOC: Dice similiarity index
- gh-12146: DOC: add docs to explain behaviour of newton's mehod on arrays
- gh-12143: BUG: Correctly use `axis` in `scipy.stats.tmean`
- gh-12071: Update _procrustes.py to handle complex matrices (#1)
- gh-12066: ENH: Exposes factor and logs WRITE in nnls
- gh-12049: Add custom leaves ordering for dendrogram
- gh-12042: Add z-score table and z-score functions
- gh-12027: ENH: hamming distance for string comparison
- gh-12000: ENH (WIP): Adds Poisson binomial distribution support (See #6000)
- gh-11955: MAINT: type sph vor function signatures
- gh-11954: ENH: faster ARGUS rv generation in scipy.stats
- gh-11846: Add ignore_nan flag to scipy.optimize.curve_fit
- gh-11829: Fixes safe handling of small singular values in svds.
- gh-11823: avoid integer overflow in NI_MinOrMaxFilter
- gh-11815: ENH: Add verbose as optional argument to solve_ivp to print time step info
- gh-11712: BUG: trust-constr evaluates function out of bounds
- gh-11650: Fix trust-constr function evaluations outside of bounds
- gh-11618: BUG: linprog returns 'infeasible' for unbounded case (fix for #11617)
- gh-11604: MAINT: swap int for long type for bdt{r,ri,rc} functions
- gh-11603: ENH: Optimise _cs_matrix._set_many when new entries are all zero
- gh-11345: MAINT: constants: revise way 'exact' values are recomputed
- gh-11344: ENH: diagonal banded form in solve banded
- gh-11313: ENH: add Wright's generalized Bessel function
- gh-11263: MAINT:optimize: Comply with user-specified rel_step
- gh-11150: [BUG] fix rvs output shape in multivariate distributions
- gh-11147: [WIP] fix some dimensionality inconsistencies
- gh-11144: Fix wavfile import for scipy.io
- gh-10860: ENH: option to reuse scipy.interpolate.RegularGridInterpolator with new values
- gh-10844: ENH: add stats.qmc module with quasi Monte Carlo functionality
- gh-10840: MAINT: use the define for NPY_NO_DEPRECATED_API, fix where needed
- gh-10778: ENH: add differential-evolution to minimize
- gh-10504: ENH: Carlson symmetric elliptic integrals.
- gh-10170: MAINT: stats: Implement cdf and ppf as ufuncs for the cosine distribution.
- gh-10129: ENH: add method that creates new spline for a partial derivative of bivariate spline
- gh-10015: skip unnecessary function calls in derivative()
- gh-9974: ENH: Truncated weibull (minimum) distribution
- gh-9948: DOC: Updated documentation for nan_policy=propagate as per #9947
- gh-9932: Add pdf_marginal and logpdf_marginal to kde
- gh-9678: ENH: Add Yuen T test
- gh-9523: ENH: improvements to the Stable distribution
- gh-9462: Cythonize ks_2samp.
- gh-9314: ENH: WIP Add support for LowLevelCallable to optimize.zeros.brenth et al
- gh-9291: Fix slow stats.fisher_exact(x) (#9231)
- gh-9075: ENH: added query_range method to KDTree class
- gh-9072: ENH: Added rectangular integral to multivariate_normal
- gh-9019: MAINT: code cleanup in optimize/linesearch
- gh-8766: Methods for pdf computation, parameter estimation, and variable sampling in stats.levy_stable. Support for different parameterizations.
- gh-8727: BUG: vq.kmeans() compares signed diff to a threshold.
- gh-8552: Scipy PEP for class based Optimizers
- gh-8529: Read wavfiles of size > 4GB
- gh-8404: relax cdflib precision to 1e-15
- gh-8305: Circular convolution
- gh-8289: DOC/ENH: Explain limitations of stats.levy_stable more explicitly
- gh-8213: MAINT: Rename sosfreqz to freqz_sos
- gh-8151: BUG: adding Buhring's analytic continuation method to special.hyp2f1; #8054
- gh-8110: BUG: special.hyp2f1 now allows neg int c value
- gh-8108: Bugfix #8103: scipy.stats.boxcox - np.nan produces warnings
- gh-7946: ENH: add a unique function for sparse matrices
- gh-7257: ENH: add rv_scatter distribution
- gh-7205: ENH: implemented kendall tau distance
- gh-6931: ENH: add weight-awareness to many functions in scipy.stats and scipy.…
- gh-6386: Improve Pinv
- gh-6345: ENH: Vectorized computations in approx_derivative
- gh-6012: Implement signal.planck (Planck-taper window)
- gh-5763: MAINT: spatial: reimplement distance_wrap in Cython
- gh-5564: BUG: fix KDTree for input with many identical values
- gh-5512: Corrected definition of pearsonr for masked arrays
- gh-5318: Added the BFGS(Hess) Algorithm for minimization independent of target function.
- gh-5025: BUG: Fix of dlsim when the system is characterized has no dynamic.
- gh-5006: MAINT: Rewrote scipy.ndimage.find_object function in cython
- gh-4872: ENH: tf2zpk positive or negative powers
- gh-4577: MNT: Use dense array for solution of spsolve
- gh-4519: Fast permutation one-way anova
- gh-4406: ENH: Implemented methods 'extended' and '3/8-th' in simps function. fixes gh-4264
- gh-4122: remezord implementation
- gh-3213: ENH Implement Jensen-Shannon Divergence
Same as this github search, with updated PRs, WIPs, and review:changes-requested excluded.
Needs decision [14]
- gh-13382: MAINT: stats: fix scoreatpercentile edge cases and add nan_policy
- gh-11193: (Draft) 64-bit BLAS/LAPACK
- gh-11165: BUG: io.matlab: Squeeze 0d to numpy scalars, not python ones
- gh-10449: Add a Gitter chat badge to README.rst
- gh-10112: ENH: minimize success should be False if solution is infeasible
- gh-8773: spsolve: separate logic for choosing method and method itself
- gh-8723: BUG: sparse.linalg: preserve column vector kind in iterative solvers
- gh-6923: optimize: API to control iteration in differential evolution
- gh-6907: differential_evolution: improve callback
- gh-6419: Added Breit-Wigner distribution
- gh-5747: [ENH] circvar calculated simply as 1-R
- gh-4933: Update the Mann-Whitney-Wilcoxon test
- gh-4904: Add root finding ode subclass. (not using the native solver's capabilities, just retracing and bisecting **in python**)
- gh-3163: ENH: add distance gufuncs to `scipy.spatial`
Same as this github search, with updated PRs and WIPs excluded.
Needs work etc. [112]
- gh-13435: (Draft) ENH: Improve MLE for von Mises distribution (`vonmises.fit`)
- gh-13403: BUG: sparse: Propagate dtype through CSR/CSC constructors
- gh-13340: (Draft) ENH: stats: Add the function odds_ratio.
- gh-13278: (Draft) BUG: integrate: Handle y0=[] in odeint.
- gh-13202: (Draft) MAINT: optimize: loosen redundancy remove and constraint check tolerances
- gh-13172: The error message “Domain error in arguments” could be more informative
- gh-13168: Address concerns in gh-12999 for ks_2samp in exact mode.
- gh-13164: (Draft) ENH: special: Add ufuncs ndtr_delta and trunc_ndtr; use trunc_ndtr for stats.truncnorm._cdf.
- gh-13096: (Draft) BUG: optimize: alternative fix for minimize issues with lb==ub
- gh-13069: (Draft) MAINT: deal with cases in `minimize` for `(bounds.lb == bounds.ub).any() (alternate for #12889)
- gh-13053: (Draft) ENH: add MLE for stats.powerlaw.fit
- gh-13008: (Draft) ENH: Add 'alternative' to functions using normal CDF for p-value
- gh-13002: (Draft) ENH: add tukeykramer to scipy.stats
- gh-12947: MAINT: Ensure that total function calls is < 'maxfev'
- gh-12933: [DOC] Add example for daub and morlet in scipy.signal
- gh-12889: (Draft) MAINT: deal with cases in `minimize` for `(bounds.lb == bounds.ub).any()
- gh-12862: WIP: REL: put upper bounds on versions of dependencies
- gh-12824: (Draft) ENH:linalg: Add backslash operations and cythonize linalg.solve
- gh-12801: ENH: Add single-sided p-values to remaining spearmanr and linregress
- gh-12745: DOC: Better description of `angles`
- gh-12704: (Draft) WIP: DOC: Cython wrapper guide
- gh-12634: ENH: Return array scalars for skew and kurtosis
- gh-12630: (Draft) WIP/ENH: stats: New ANOVA functions.
- gh-12592: WIP: HOSVD implementation
- gh-12512: (Draft) ENH: Allow user configuration of pocketfft's plan caches
- gh-12507: (Draft) WIP: wavfile.read different integer output formats
- gh-12386: (Draft) ENH: Optimized code for Euclidian distances in cKDTree
- gh-12288: (Draft) ENH: stats: Add the conditional odds ratio and CI to fisher_exact.
- gh-12120: TST: best fun should be OptimizeResult.fun
- gh-11985: WIP: Add wrapper for ?pbsvx
- gh-11890: WIP: Python wrapper for ?gbsvx
- gh-11888: WIP, arffread.py -- redundant if-condition
- gh-11754: ENH: stats: Updates to `variation`.
- gh-11502: (Draft) WIP: alpha shapes
- gh-11257: WIP: sparse redundancy removal routine optimizations
- gh-11212: Improved Radial Basis Function Interpolation
- gh-11158: (Draft) WIP: Remove 0d/1d special-casing from _numdiff
- gh-11148: WIP: DOC: examples for docstrings in scipy.stats
- gh-11143: WIP: Add constants.svg tree
- gh-11129: WIP: DOC: convert hyperlinks to interlinks
- gh-11030: WIP: Adjust digital filter design warnings
- gh-10871: handle duplicate x_min values in interp1d
- gh-10625: Make appendmat actually append ".mat".
- gh-10623: ENH: Simplify filter_type in *ord() functions
- gh-10519: [DOC] More accurate docstring of nan policy=propagate in some descriptive statistics
- gh-10511: WIP, ENH: Reduce fft sizes for zero-padded arrays
- gh-10454: ENH: Extend find_peaks_cwt to take numbers and iterables for widths argument.
- gh-10375: (Draft) ENH: sparse/linalg/arpack: Upgrade arpack-ng to 3.7.0
- gh-10102: FIX: now can calculate distances correctly, regardless of type
- gh-10039: MAINT: malloc checks for C source files
- gh-9973: (Draft) ENH: speed up multivariate_normal.logpdf for nonsingular matrices
- gh-9957: MAINT: fix sparse matrix comparison operator overloading
- gh-9839: ENH: scipy.optimize.minimize with method=SLSQP returns KKT multipliers
- gh-9735: WIP: discrete Frechet distance function in scipy.spatial.distance
- gh-8896: FIX: generating random sparse matrix with size > max(int32)
- gh-8835: ENH/TST: Update Newton's method.
- gh-8818: WIP/ENH: Allow r to be an array for cKDTree.query_ball_point
- gh-8775: ENH: added accept_rate as a keyword to basinhopping
- gh-8707: (Draft) WIP/ENH: datasets: Create the datasets subpackage.
- gh-8679: Stop astype from overwriting arrays when copy=True
- gh-8525: ENH: scipy.sparse: add method for (faster) lil matrix vector multiplication
- gh-8472: ENH: in scipy.sparse.linalg.norm implement spectral norm
- gh-8414: WIP: Class based Optimizers
- gh-8360: BUG: Issue #4464 Fixed residuez which failed for Complex Numbers
- gh-8286: WIP: ENH: Add rank-1 Cholesky update/downdate
- gh-7903: ENH: add more interpolation methods to RegularGridInterpolator.
- gh-7819: (Draft) WIP: Basin hopping improvements
- gh-7800: WIP: Adding a valgrind tool script.
- gh-7569: WIP: Implement LineBufferIterator class and wrappers.
- gh-7425: ENH: optimize: more complete callback signature
- gh-7127: ENH: Add infrastructure for sparse in-place interface.
- gh-6870: _cs_matrix: warn about bigger data/indices in check_format
- gh-6852: WIP: adding 24-bit support to io.wavfile
- gh-6837: ENH: Add lanczos window to scipy.signal.windows
- gh-6832: WIP: SOS LTI systems
- gh-6739: added Normal inverse gamma distribution
- gh-6736: DOC, ENH: run linkchecker on html docs after refguide check & fix broken links
- gh-6617: ENH: instantiate sparse.lil_matrix with data
- gh-6482: ENH: add a function for Gauss-Hermite quadrature
- gh-6466: WIP: arbitrary continuous distribution
- gh-6331: WIP: sparse.linalg: Convert `spsolve` to `solve_banded` for DIA matrix inputs
- gh-6089: Make distance functions broadcasting
- gh-6066: Seperate out the creation of a Gaussian kernel from the filtering
- gh-6053: BUG: savemat does not save keys starting with underscore
- gh-6004: Add fast_lil_matrix sparse matrix
- gh-5952: Allow for absolute finite difference step
- gh-5886: WIP - BUG: scipy.signal.lsim overflow error
- gh-5819: Fixes for #2324 rankdata returns wrong results on masked arrays
- gh-5775: ENH: Add infrastructure for sparse in-place @ with gemm interface
- gh-5737: ENH: Added transfer function estimation
- gh-5619: Faster block_diag when blocks are equally shaped
- gh-5591: Fixed SparseMatrixOperator to correctly implement adjoint.
- gh-5327: BUG: io: Fix savemat compression OverflowError
- gh-5288: BUG: multivariate_normal returns a pdf for values outside its support when covariance is singular
- gh-5109: MAINT: Cython version of distance_transform_bruteforce function of mo…
- gh-5087: Remove more uses of inv() and replace with cho_solve()
- gh-5031: Extend to_writable method to array-like
- gh-5012: ENH: add 'alternative' and 'exact' keywords to `stats.ansari`
- gh-4697: Extrapolate Anderson-Darling p-values linearly.
- gh-4674: WIP: ENH: interpolate: add rational interpolation
- gh-4460: WIP: add SQUAREM for fixed point problems
- gh-4459: ENH: optimize: add stagnation check to df-sane
- gh-4444: BF: use UTF16 for saving unicode to mat files
- gh-4384: ENH: optimize, returning True from callback function halts minimization
- gh-4279: Kdtree subset query
- gh-4166: A faster DFS implementation: (i) linear (ii) releases gil. Some assumpti...
- gh-3597: Use real names when loading MATLAB opaque objects.
- gh-3535: sparse arff
- gh-3472: Hankel transforms for scipy.signal
- gh-3260: This adds root finding to pchip as this is possible to do optimal because pchip is a monotonic interpolation.
- gh-2862: Enable simulation of MIMO systems
- gh-354: Faster expm
Same as this and this github search, with updated PRs excluded and WIPs included.
Needs champion [15]
- gh-6470: A better Brent's method implementation
- gh-5141: ENH: Parallel differential evolution
- gh-5120: ENH: use derivatives for boxcox transformation parameter and error estimation
- gh-5119: More efficient median binned stat calculation and new min & max binned stats
- gh-5113: MAINT: more data validation for boxcox transformation
- gh-5062: MAINT: fancy indexing of a sparse matrix now returns a sparse matrix
- gh-4934: WIP: fix an expm typo.
- gh-4886: MAINT: svd-based mahalanobis distance
- gh-4689: MAINT: simplify some indexing code in sparse matrix sampling
- gh-4294: MAINT: pchanial's improvement of input validation in sparse's __mul__
- gh-4115: ENH: associated Legendre function of second kind with types 2 and 3
- gh-3659: added cramer von-mises two sample test
- gh-3406: clarify scipy.cluster.hierarchy.linkage usage
- gh-2974: ENH: Alex Leach's wrapper of Roger Sidje's EXPOKIT
- gh-435: MAINT: special: deprecate truncate-to-int behavior
Same as this github search.
Needs backport [9]
- gh-13430: BUG: stats: Fix exponnorm.cdf and exponnorm.sf for small K
- gh-13426: BUG: `has_sorted_indices` and `has_canonical_format` should be bools
- gh-13422: FIX: optimize: use npy_intp to store array dims for lsap
- gh-13414: BUG: maintain dtype of SphericalVoronoi regions
- gh-13400: BUG: sparse: Better validation for BSR ctor
- gh-13394: BUG: Fix Python crash by allocating larger array in LSQBivariateSpline
- gh-13387: BUG: Support big-endian platforms and big-endian WAVs
- gh-13345: MAINT: Replace scipy.take with numpy.take in FFT function docstrings.
- gh-13344: BUG: fftpack doesn't work with ndarray shape argument
Same as this github search.
Generated by github-needs-work