<div dir="ltr">Hi all,<br><div><br><div>On behalf of the <span><span class="il">Scipy</span></span> development team I'm pleased to announce the availability of <span><span><span><span><span><span><span class="il">Scipy</span></span></span></span></span></span></span>
 <span><span>0</span></span>.16.<span><span>0</span></span>.
 This <span class="il">release</span> contains some exciting new features (see <span class="il">release</span> notes 
below) and more than half a years' worth of maintenance work. 93 people 
contributed to this <span class="il">release</span>.<br>
<br>This
 <span class="il">release</span> requires Python 2.6, 2.7 or 3.2-3.4 and <span class="il">NumPy</span> 1.6.2 or greater.
 Sources, binaries and release notes can be found at <a href="https://github.com/scipy/scipy/releases/tag/v0.16.0">https://github.com/scipy/scipy/releases/tag/v0.16.0 </a><br></div><div><br>Enjoy,<br>

</div>Ralf<br><br><br><br><br>-----BEGIN PGP SIGNED MESSAGE-----<br>Hash: SHA1<br><br>==========================<br>SciPy 0.16.0 Release Notes<br>==========================<br><br>SciPy 0.16.0 is the culmination of 7 months of hard work. It contains<br>many new features, numerous bug-fixes, improved test coverage and<br>better documentation.  There have been a number of deprecations and<br>API changes in this release, which are documented below.  All users<br>are encouraged to upgrade to this release, as there are a large number<br>of bug-fixes and optimizations.  Moreover, our development attention<br>will now shift to bug-fix releases on the 0.16.x branch, and on adding<br>new features on the master branch.<br><br>This release requires Python 2.6, 2.7 or 3.2-3.4 and NumPy 1.6.2 or greater.<br><br>Highlights of this release include:<br><br>- - A Cython API for BLAS/LAPACK in `scipy.linalg`<br>- - A new benchmark suite.  It's now straightforward to add new benchmarks, and<br>  they're routinely included with performance enhancement PRs.<br>- - Support for the second order sections (SOS) format in `scipy.signal`.<br><br><br>New features<br>============<br><br>Benchmark suite<br>- ---------------<br><br>The benchmark suite has switched to using `Airspeed Velocity<br><<a href="http://spacetelescope.github.io/asv/">http://spacetelescope.github.io/asv/</a>>`__ for benchmarking. You can<br>run the suite locally via ``python runtests.py --bench``. For more<br>details, see ``benchmarks/README.rst``.<br><br>`scipy.linalg` improvements<br>- ---------------------------<br><br>A full set of Cython wrappers for BLAS and LAPACK has been added in the<br>modules `scipy.linalg.cython_blas` and `scipy.linalg.cython_lapack`.<br>In Cython, these wrappers can now be cimported from their corresponding<br>modules and used without linking directly against BLAS or LAPACK.<br><br>The functions `scipy.linalg.qr_delete`, `scipy.linalg.qr_insert` and<br>`scipy.linalg.qr_update` for updating QR decompositions were added.<br><br>The function `scipy.linalg.solve_circulant` solves a linear system with<br>a circulant coefficient matrix.<br><br>The function `scipy.linalg.invpascal` computes the inverse of a Pascal matrix.<br><br>The function `scipy.linalg.solve_toeplitz`, a Levinson-Durbin Toeplitz solver,<br>was added.<br><br>Added wrapper for potentially useful LAPACK function ``*lasd4``.  It computes<br>the square root of the i-th updated eigenvalue of a positive symmetric rank-one<br>modification to a positive diagonal matrix. See its LAPACK documentation and<br>unit tests for it to get more info.<br><br>Added two extra wrappers for LAPACK least-square solvers. Namely, they are <br>``*gelsd`` and ``*gelsy``.<br><br>Wrappers for the LAPACK ``*lange`` functions, which calculate various matrix<br>norms, were added.<br><br>Wrappers for ``*gtsv`` and ``*ptsv``, which solve ``A*X = B`` for tri-diagonal<br>matrix ``A``, were added.<br><br>`scipy.signal` improvements<br>- ---------------------------<br><br>Support for second order sections (SOS) as a format for IIR filters<br>was added.  The new functions are:<br><br>* `scipy.signal.sosfilt`<br>* `scipy.signal.sosfilt_zi`,<br>* `scipy.signal.sos2tf`<br>* `scipy.signal.sos2zpk`<br>* `scipy.signal.tf2sos`<br>* `scipy.signal.zpk2sos`.<br><br>Additionally, the filter design functions `iirdesign`, `iirfilter`, `butter`,<br>`cheby1`, `cheby2`, `ellip`, and `bessel` can return the filter in the SOS<br>format.<br><br>The function `scipy.signal.place_poles`, which provides two methods to place<br>poles for linear systems, was added.<br><br>The option to use Gustafsson's method for choosing the initial conditions<br>of the forward and backward passes was added to `scipy.signal.filtfilt`.<br><br>New classes ``TransferFunction``, ``StateSpace`` and ``ZerosPolesGain`` were<br>added.  These classes are now returned when instantiating `scipy.signal.lti`.<br>Conversion between those classes can be done explicitly now.<br><br>An exponential (Poisson) window was added as `scipy.signal.exponential`, and a<br>Tukey window was added as `scipy.signal.tukey`.<br><br>The function for computing digital filter group delay was added as<br>`scipy.signal.group_delay`.<br><br>The functionality for spectral analysis and spectral density estimation has<br>been significantly improved: `scipy.signal.welch` became ~8x faster and the<br>functions `scipy.signal.spectrogram`, `scipy.signal.coherence` and<br>`scipy.signal.csd` (cross-spectral density) were added.<br><br>`scipy.signal.lsim` was rewritten - all known issues are fixed, so this<br>function can now be used instead of ``lsim2``; ``lsim`` is orders of magnitude<br>faster than ``lsim2`` in most cases.<br><br>`scipy.sparse` improvements<br>- ---------------------------<br><br>The function `scipy.sparse.norm`, which computes sparse matrix norms, was<br>added.<br><br>The function `scipy.sparse.random`, which allows to draw random variates from<br>an arbitrary distribution, was added.<br><br>`scipy.spatial` improvements<br>- ----------------------------<br><br>`scipy.spatial.cKDTree` has seen a major rewrite, which improved the<br>performance of the ``query`` method significantly, added support for parallel<br>queries, pickling, and options that affect the tree layout.  See pull request<br>4374 for more details.<br><br>The function `scipy.spatial.procrustes` for Procrustes analysis (statistical<br>shape analysis) was added.<br><br>`scipy.stats` improvements<br>- --------------------------<br><br>The Wishart distribution and its inverse have been added, as<br>`scipy.stats.wishart` and `scipy.stats.invwishart`.<br><br>The Exponentially Modified Normal distribution has been<br>added as `scipy.stats.exponnorm`.<br><br>The Generalized Normal distribution has been added as `scipy.stats.gennorm`.<br><br>All distributions now contain a ``random_state`` property and allow specifying a<br>specific ``numpy.random.RandomState`` random number generator when generating<br>random variates.<br><br>Many statistical tests and other `scipy.stats` functions that have multiple<br>return values now return ``namedtuples``.  See pull request 4709 for details.<br><br>`scipy.optimize` improvements<br>- -----------------------------<br><br>A new derivative-free method DF-SANE has been added to the nonlinear equation<br>system solving function `scipy.optimize.root`.<br><br><br>Deprecated features<br>===================<br><br>``scipy.stats.pdf_fromgamma`` is deprecated.  This function was undocumented,<br>untested and rarely used.  Statsmodels provides equivalent functionality<br>with ``statsmodels.distributions.ExpandedNormal``.<br><br>``scipy.stats.fastsort`` is deprecated.  This function is unnecessary,<br>``numpy.argsort`` can be used instead.<br><br>``scipy.stats.signaltonoise`` and ``scipy.stats.mstats.signaltonoise`` are<br>deprecated.  These functions did not belong in ``scipy.stats`` and are rarely<br>used.  See issue #609 for details.<br><br>``scipy.stats.histogram2`` is deprecated. This function is unnecessary, <br>``numpy.histogram2d`` can be used instead.<br><br>Backwards incompatible changes<br>==============================<br><br>The deprecated global optimizer ``scipy.optimize.anneal`` was removed.<br><br>The following deprecated modules have been removed: ``scipy.lib.blas``,<br>``scipy.lib.lapack``, ``scipy.linalg.cblas``, ``scipy.linalg.fblas``,<br>``scipy.linalg.clapack``, ``scipy.linalg.flapack``.  They had been deprecated<br>since Scipy 0.12.0, the functionality should be accessed as `scipy.linalg.blas`<br>and `scipy.linalg.lapack`.<br><br>The deprecated function ``scipy.special.all_mat`` has been removed.<br><br>The deprecated functions ``fprob``, ``ksprob``, ``zprob``, ``randwcdf``<br>and ``randwppf`` have been removed from `scipy.stats`.<br><br><br>Other changes<br>=============<br><br>The version numbering for development builds has been updated to comply with PEP 440.<br><br>Building with ``python setup.py develop`` is now supported.<br><br><br>Authors<br>=======<br><br>* @axiru +<br>* @endolith<br>* Elliott Sales de Andrade +<br>* Anne Archibald<br>* Yoshiki Vázquez Baeza +<br>* Sylvain Bellemare<br>* Felix Berkenkamp +<br>* Raoul Bourquin +<br>* Matthew Brett<br>* Per Brodtkorb<br>* Christian Brueffer<br>* Lars Buitinck<br>* Evgeni Burovski<br>* Steven Byrnes<br>* CJ Carey<br>* George Castillo +<br>* Alex Conley +<br>* Liam Damewood +<br>* Rupak Das +<br>* Abraham Escalante +<br>* Matthias Feurer +<br>* Eric Firing +<br>* Clark Fitzgerald<br>* Chad Fulton<br>* André Gaul<br>* Andreea Georgescu +<br>* Christoph Gohlke<br>* Andrey Golovizin +<br>* Ralf Gommers<br>* J.J. Green +<br>* Alex Griffing<br>* Alexander Grigorievskiy +<br>* Hans Moritz Gunther +<br>* Jonas Hahnfeld +<br>* Charles Harris<br>* Ian Henriksen<br>* Andreas Hilboll<br>* Åsmund Hjulstad +<br>* Jan Schlüter +<br>* Janko Slavič +<br>* Daniel Jensen +<br>* Johannes Ballé +<br>* Terry Jones +<br>* Amato Kasahara +<br>* Eric Larson<br>* Denis Laxalde<br>* Antony Lee<br>* Gregory R. Lee<br>* Perry Lee +<br>* Loïc Estève<br>* Martin Manns +<br>* Eric Martin +<br>* Matěj Kocián +<br>* Andreas Mayer +<br>* Nikolay Mayorov +<br>* Robert McGibbon +<br>* Sturla Molden<br>* Nicola Montecchio +<br>* Eric Moore<br>* Jamie Morton +<br>* Nikolas Moya +<br>* Maniteja Nandana +<br>* Andrew Nelson<br>* Joel Nothman<br>* Aldrian Obaja<br>* Regina Ongowarsito +<br>* Paul Ortyl +<br>* Pedro López-Adeva Fernández-Layos +<br>* Stefan Peterson +<br>* Irvin Probst +<br>* Eric Quintero +<br>* John David Reaver +<br>* Juha Remes +<br>* Thomas Robitaille<br>* Clancy Rowley +<br>* Tobias Schmidt +<br>* Skipper Seabold<br>* Aman Singh +<br>* Eric Soroos<br>* Valentine Svensson +<br>* Julian Taylor<br>* Aman Thakral +<br>* Helmut Toplitzer +<br>* Fukumu Tsutsumi +<br>* Anastasiia Tsyplia +<br>* Jacob Vanderplas<br>* Pauli Virtanen<br>* Matteo Visconti +<br>* Warren Weckesser<br>* Florian Wilhelm +<br>* Nathan Woods<br>* Haochen Wu +<br>* Daan Wynen +<br><br>A total of 93 people contributed to this release.<br>People with a "+" by their names contributed a patch for the first time.<br>This list of names is automatically generated, and may not be fully complete.<br><br><br>Issues closed for 0.16.0<br>- ------------------------<br><br>- - `#1063 <<a href="https://github.com/scipy/scipy/issues/1063">https://github.com/scipy/scipy/issues/1063</a>>`__: Implement a whishart distribution (Trac #536)<br>- - `#1885 <<a href="https://github.com/scipy/scipy/issues/1885">https://github.com/scipy/scipy/issues/1885</a>>`__: Rbf: floating point warnings - possible bug (Trac #1360)<br>- - `#2020 <<a href="https://github.com/scipy/scipy/issues/2020">https://github.com/scipy/scipy/issues/2020</a>>`__: Rbf default epsilon too large (Trac #1495)<br>- - `#2325 <<a href="https://github.com/scipy/scipy/issues/2325">https://github.com/scipy/scipy/issues/2325</a>>`__: extending distributions, hypergeom, to degenerate cases (Trac...<br>- - `#3502 <<a href="https://github.com/scipy/scipy/issues/3502">https://github.com/scipy/scipy/issues/3502</a>>`__: [ENH] linalg.hessenberg should use ORGHR for calc_q=True<br>- - `#3603 <<a href="https://github.com/scipy/scipy/issues/3603">https://github.com/scipy/scipy/issues/3603</a>>`__: Passing array as window into signal.resample() fails<br>- - `#3675 <<a href="https://github.com/scipy/scipy/issues/3675">https://github.com/scipy/scipy/issues/3675</a>>`__: Intermittent failures for signal.slepian on Windows<br>- - `#3742 <<a href="https://github.com/scipy/scipy/issues/3742">https://github.com/scipy/scipy/issues/3742</a>>`__: Pchipinterpolator inconvenient as ppoly<br>- - `#3786 <<a href="https://github.com/scipy/scipy/issues/3786">https://github.com/scipy/scipy/issues/3786</a>>`__: add procrustes?<br>- - `#3798 <<a href="https://github.com/scipy/scipy/issues/3798">https://github.com/scipy/scipy/issues/3798</a>>`__: scipy.io.savemat fails for empty dicts<br>- - `#3975 <<a href="https://github.com/scipy/scipy/issues/3975">https://github.com/scipy/scipy/issues/3975</a>>`__: Use RandomState in scipy.stats<br>- - `#4022 <<a href="https://github.com/scipy/scipy/issues/4022">https://github.com/scipy/scipy/issues/4022</a>>`__: savemat incorrectly saves logical arrays<br>- - `#4028 <<a href="https://github.com/scipy/scipy/issues/4028">https://github.com/scipy/scipy/issues/4028</a>>`__: scipy.stats.geom.logpmf(1,1) returns nan. The correct value is...<br>- - `#4030 <<a href="https://github.com/scipy/scipy/issues/4030">https://github.com/scipy/scipy/issues/4030</a>>`__: simplify scipy.stats.betaprime.cdf<br>- - `#4031 <<a href="https://github.com/scipy/scipy/issues/4031">https://github.com/scipy/scipy/issues/4031</a>>`__: improve accuracy of scipy.stats.gompertz distribution for small...<br>- - `#4033 <<a href="https://github.com/scipy/scipy/issues/4033">https://github.com/scipy/scipy/issues/4033</a>>`__: improve accuracy of scipy.stats.lomax distribution for small...<br>- - `#4034 <<a href="https://github.com/scipy/scipy/issues/4034">https://github.com/scipy/scipy/issues/4034</a>>`__: improve accuracy of scipy.stats.rayleigh distribution for large...<br>- - `#4035 <<a href="https://github.com/scipy/scipy/issues/4035">https://github.com/scipy/scipy/issues/4035</a>>`__: improve accuracy of scipy.stats.truncexpon distribution for small...<br>- - `#4081 <<a href="https://github.com/scipy/scipy/issues/4081">https://github.com/scipy/scipy/issues/4081</a>>`__: Error when reading matlab file: buffer is too small for requested...<br>- - `#4100 <<a href="https://github.com/scipy/scipy/issues/4100">https://github.com/scipy/scipy/issues/4100</a>>`__: Why does qr(a, lwork=0) not fail?<br>- - `#4134 <<a href="https://github.com/scipy/scipy/issues/4134">https://github.com/scipy/scipy/issues/4134</a>>`__: scipy.stats: rv_frozen has no expect() method<br>- - `#4204 <<a href="https://github.com/scipy/scipy/issues/4204">https://github.com/scipy/scipy/issues/4204</a>>`__: Please add docstring to scipy.optimize.RootResults<br>- - `#4206 <<a href="https://github.com/scipy/scipy/issues/4206">https://github.com/scipy/scipy/issues/4206</a>>`__: Wrap LAPACK tridiagonal solve routine `gtsv`<br>- - `#4208 <<a href="https://github.com/scipy/scipy/issues/4208">https://github.com/scipy/scipy/issues/4208</a>>`__: Empty sparse matrices written to MAT file cannot be read by MATLAB<br>- - `#4217 <<a href="https://github.com/scipy/scipy/issues/4217">https://github.com/scipy/scipy/issues/4217</a>>`__: use a TravisCI configuration with numpy built with NPY_RELAXED_STRIDES_CHECKING=1<br>- - `#4282 <<a href="https://github.com/scipy/scipy/issues/4282">https://github.com/scipy/scipy/issues/4282</a>>`__: integrate.odeint raises an exception when full_output=1 and the...<br>- - `#4301 <<a href="https://github.com/scipy/scipy/issues/4301">https://github.com/scipy/scipy/issues/4301</a>>`__: scipy and numpy version names do not follow pep 440<br>- - `#4355 <<a href="https://github.com/scipy/scipy/issues/4355">https://github.com/scipy/scipy/issues/4355</a>>`__: PPoly.antiderivative() produces incorrect output<br>- - `#4391 <<a href="https://github.com/scipy/scipy/issues/4391">https://github.com/scipy/scipy/issues/4391</a>>`__: spsolve becomes extremely slow with large b matrix<br>- - `#4393 <<a href="https://github.com/scipy/scipy/issues/4393">https://github.com/scipy/scipy/issues/4393</a>>`__: Documentation glitsch in sparse.linalg.spilu<br>- - `#4408 <<a href="https://github.com/scipy/scipy/issues/4408">https://github.com/scipy/scipy/issues/4408</a>>`__: Vector-valued constraints in minimize() et al<br>- - `#4412 <<a href="https://github.com/scipy/scipy/issues/4412">https://github.com/scipy/scipy/issues/4412</a>>`__: Documentation of scipy.signal.cwt error<br>- - `#4428 <<a href="https://github.com/scipy/scipy/issues/4428">https://github.com/scipy/scipy/issues/4428</a>>`__: dok.__setitem__ problem with negative indices<br>- - `#4434 <<a href="https://github.com/scipy/scipy/issues/4434">https://github.com/scipy/scipy/issues/4434</a>>`__: Incomplete documentation for sparse.linalg.spsolve<br>- - `#4438 <<a href="https://github.com/scipy/scipy/issues/4438">https://github.com/scipy/scipy/issues/4438</a>>`__: linprog() documentation example wrong<br>- - `#4445 <<a href="https://github.com/scipy/scipy/issues/4445">https://github.com/scipy/scipy/issues/4445</a>>`__: Typo in scipy.special.expit doc<br>- - `#4467 <<a href="https://github.com/scipy/scipy/issues/4467">https://github.com/scipy/scipy/issues/4467</a>>`__: Documentation Error in scipy.optimize options for TNC<br>- - `#4492 <<a href="https://github.com/scipy/scipy/issues/4492">https://github.com/scipy/scipy/issues/4492</a>>`__: solve_toeplitz benchmark is bitrotting already<br>- - `#4506 <<a href="https://github.com/scipy/scipy/issues/4506">https://github.com/scipy/scipy/issues/4506</a>>`__: lobpcg/sparse performance regression Jun 2014?<br>- - `#4520 <<a href="https://github.com/scipy/scipy/issues/4520">https://github.com/scipy/scipy/issues/4520</a>>`__: g77_abi_wrappers needed on Linux for MKL as well<br>- - `#4521 <<a href="https://github.com/scipy/scipy/issues/4521">https://github.com/scipy/scipy/issues/4521</a>>`__: Broken check in uses_mkl for newer versions of the library<br>- - `#4523 <<a href="https://github.com/scipy/scipy/issues/4523">https://github.com/scipy/scipy/issues/4523</a>>`__: rbf with gaussian kernel seems to produce more noise than original...<br>- - `#4526 <<a href="https://github.com/scipy/scipy/issues/4526">https://github.com/scipy/scipy/issues/4526</a>>`__: error in site documentation for poisson.pmf() method<br>- - `#4527 <<a href="https://github.com/scipy/scipy/issues/4527">https://github.com/scipy/scipy/issues/4527</a>>`__: KDTree example doesn't work in Python 3<br>- - `#4550 <<a href="https://github.com/scipy/scipy/issues/4550">https://github.com/scipy/scipy/issues/4550</a>>`__: `scipy.stats.mode` - UnboundLocalError on empty sequence<br>- - `#4554 <<a href="https://github.com/scipy/scipy/issues/4554">https://github.com/scipy/scipy/issues/4554</a>>`__: filter out convergence warnings in optimization tests<br>- - `#4565 <<a href="https://github.com/scipy/scipy/issues/4565">https://github.com/scipy/scipy/issues/4565</a>>`__: odeint messages<br>- - `#4569 <<a href="https://github.com/scipy/scipy/issues/4569">https://github.com/scipy/scipy/issues/4569</a>>`__: remez: "ValueError: Failure to converge after 25 iterations....<br>- - `#4582 <<a href="https://github.com/scipy/scipy/issues/4582">https://github.com/scipy/scipy/issues/4582</a>>`__: DOC: optimize: _minimize_scalar_brent does not have a disp option<br>- - `#4585 <<a href="https://github.com/scipy/scipy/issues/4585">https://github.com/scipy/scipy/issues/4585</a>>`__: DOC: Erroneous latex-related characters in tutorial.<br>- - `#4590 <<a href="https://github.com/scipy/scipy/issues/4590">https://github.com/scipy/scipy/issues/4590</a>>`__: sparse.linalg.svds should throw an exception if which not in...<br>- - `#4594 <<a href="https://github.com/scipy/scipy/issues/4594">https://github.com/scipy/scipy/issues/4594</a>>`__: scipy.optimize.linprog IndexError when a callback is providen<br>- - `#4596 <<a href="https://github.com/scipy/scipy/issues/4596">https://github.com/scipy/scipy/issues/4596</a>>`__: scipy.linalg.block_diag misbehavior with empty array inputs (v0.13.3)<br>- - `#4599 <<a href="https://github.com/scipy/scipy/issues/4599">https://github.com/scipy/scipy/issues/4599</a>>`__: scipy.integrate.nquad should call _OptFunc when called with only...<br>- - `#4612 <<a href="https://github.com/scipy/scipy/issues/4612">https://github.com/scipy/scipy/issues/4612</a>>`__: Crash in signal.lfilter on nd input with wrong shaped zi<br>- - `#4613 <<a href="https://github.com/scipy/scipy/issues/4613">https://github.com/scipy/scipy/issues/4613</a>>`__: scipy.io.readsav error on reading sav file<br>- - `#4673 <<a href="https://github.com/scipy/scipy/issues/4673">https://github.com/scipy/scipy/issues/4673</a>>`__: scipy.interpolate.RectBivariateSpline construction locks PyQt...<br>- - `#4681 <<a href="https://github.com/scipy/scipy/issues/4681">https://github.com/scipy/scipy/issues/4681</a>>`__: Broadcasting in signal.lfilter still not quite right.<br>- - `#4705 <<a href="https://github.com/scipy/scipy/issues/4705">https://github.com/scipy/scipy/issues/4705</a>>`__: kmeans k_or_guess parameter error if guess is not square array<br>- - `#4719 <<a href="https://github.com/scipy/scipy/issues/4719">https://github.com/scipy/scipy/issues/4719</a>>`__: Build failure on 14.04.2<br>- - `#4724 <<a href="https://github.com/scipy/scipy/issues/4724">https://github.com/scipy/scipy/issues/4724</a>>`__: GenGamma _munp function fails due to overflow<br>- - `#4726 <<a href="https://github.com/scipy/scipy/issues/4726">https://github.com/scipy/scipy/issues/4726</a>>`__: FAIL: test_cobyla.test_vector_constraints<br>- - `#4734 <<a href="https://github.com/scipy/scipy/issues/4734">https://github.com/scipy/scipy/issues/4734</a>>`__: Failing tests in stats with numpy master.<br>- - `#4736 <<a href="https://github.com/scipy/scipy/issues/4736">https://github.com/scipy/scipy/issues/4736</a>>`__: qr_update bug or incompatibility with numpy 1.10?<br>- - `#4746 <<a href="https://github.com/scipy/scipy/issues/4746">https://github.com/scipy/scipy/issues/4746</a>>`__: linprog returns solution violating equality constraint<br>- - `#4757 <<a href="https://github.com/scipy/scipy/issues/4757">https://github.com/scipy/scipy/issues/4757</a>>`__: optimize.leastsq docstring mismatch<br>- - `#4774 <<a href="https://github.com/scipy/scipy/issues/4774">https://github.com/scipy/scipy/issues/4774</a>>`__: Update contributor list for v0.16<br>- - `#4779 <<a href="https://github.com/scipy/scipy/issues/4779">https://github.com/scipy/scipy/issues/4779</a>>`__: circmean and others do not appear in the documentation<br>- - `#4788 <<a href="https://github.com/scipy/scipy/issues/4788">https://github.com/scipy/scipy/issues/4788</a>>`__: problems with scipy sparse linalg isolve iterative.py when complex<br>- - `#4791 <<a href="https://github.com/scipy/scipy/issues/4791">https://github.com/scipy/scipy/issues/4791</a>>`__: BUG: scipy.spatial: incremental Voronoi doesn't increase size...<br><br><br>Pull requests for 0.16.0<br>- ------------------------<br><br>- - `#3116 <<a href="https://github.com/scipy/scipy/pull/3116">https://github.com/scipy/scipy/pull/3116</a>>`__: sparse: enhancements for DIA format<br>- - `#3157 <<a href="https://github.com/scipy/scipy/pull/3157">https://github.com/scipy/scipy/pull/3157</a>>`__: ENH: linalg: add the function 'solve_circulant' for solving a...<br>- - `#3442 <<a href="https://github.com/scipy/scipy/pull/3442">https://github.com/scipy/scipy/pull/3442</a>>`__: ENH: signal: Add Gustafsson's method as an option for the filtfilt...<br>- - `#3679 <<a href="https://github.com/scipy/scipy/pull/3679">https://github.com/scipy/scipy/pull/3679</a>>`__: WIP: fix sporadic slepian failures<br>- - `#3680 <<a href="https://github.com/scipy/scipy/pull/3680">https://github.com/scipy/scipy/pull/3680</a>>`__: Some cleanups in stats<br>- - `#3717 <<a href="https://github.com/scipy/scipy/pull/3717">https://github.com/scipy/scipy/pull/3717</a>>`__: ENH: Add second-order sections filtering<br>- - `#3741 <<a href="https://github.com/scipy/scipy/pull/3741">https://github.com/scipy/scipy/pull/3741</a>>`__: Dltisys changes<br>- - `#3956 <<a href="https://github.com/scipy/scipy/pull/3956">https://github.com/scipy/scipy/pull/3956</a>>`__: add note to scipy.signal.resample about prime sample numbers<br>- - `#3980 <<a href="https://github.com/scipy/scipy/pull/3980">https://github.com/scipy/scipy/pull/3980</a>>`__: Add check_finite flag to UnivariateSpline<br>- - `#3996 <<a href="https://github.com/scipy/scipy/pull/3996">https://github.com/scipy/scipy/pull/3996</a>>`__: MAINT: stricter linalg argument checking<br>- - `#4001 <<a href="https://github.com/scipy/scipy/pull/4001">https://github.com/scipy/scipy/pull/4001</a>>`__: BUG: numerical precision in dirichlet<br>- - `#4012 <<a href="https://github.com/scipy/scipy/pull/4012">https://github.com/scipy/scipy/pull/4012</a>>`__: ENH: linalg: Add a function to compute the inverse of a Pascal...<br>- - `#4021 <<a href="https://github.com/scipy/scipy/pull/4021">https://github.com/scipy/scipy/pull/4021</a>>`__: ENH: Cython api for lapack and blas<br>- - `#4089 <<a href="https://github.com/scipy/scipy/pull/4089">https://github.com/scipy/scipy/pull/4089</a>>`__: Fixes for various PEP8 issues.<br>- - `#4116 <<a href="https://github.com/scipy/scipy/pull/4116">https://github.com/scipy/scipy/pull/4116</a>>`__: MAINT: fitpack: trim down compiler warnings (unused labels, variables)<br>- - `#4129 <<a href="https://github.com/scipy/scipy/pull/4129">https://github.com/scipy/scipy/pull/4129</a>>`__: ENH: stats: add a random_state property to distributions<br>- - `#4135 <<a href="https://github.com/scipy/scipy/pull/4135">https://github.com/scipy/scipy/pull/4135</a>>`__: ENH: Add Wishart and inverse Wishart distributions<br>- - `#4195 <<a href="https://github.com/scipy/scipy/pull/4195">https://github.com/scipy/scipy/pull/4195</a>>`__: improve the interpolate docs<br>- - `#4200 <<a href="https://github.com/scipy/scipy/pull/4200">https://github.com/scipy/scipy/pull/4200</a>>`__: ENH: Add t-test from descriptive stats function.<br>- - `#4202 <<a href="https://github.com/scipy/scipy/pull/4202">https://github.com/scipy/scipy/pull/4202</a>>`__: Dendrogram threshold color<br>- - `#4205 <<a href="https://github.com/scipy/scipy/pull/4205">https://github.com/scipy/scipy/pull/4205</a>>`__: BLD: fix a number of Bento build warnings.<br>- - `#4211 <<a href="https://github.com/scipy/scipy/pull/4211">https://github.com/scipy/scipy/pull/4211</a>>`__: add an ufunc for the inverse Box-Cox transfrom<br>- - `#4212 <<a href="https://github.com/scipy/scipy/pull/4212">https://github.com/scipy/scipy/pull/4212</a>>`__: MRG:fix for gh-4208<br>- - `#4213 <<a href="https://github.com/scipy/scipy/pull/4213">https://github.com/scipy/scipy/pull/4213</a>>`__: ENH: specific warning if matlab file is empty<br>- - `#4215 <<a href="https://github.com/scipy/scipy/pull/4215">https://github.com/scipy/scipy/pull/4215</a>>`__: Issue #4209: splprep documentation updated to reflect dimensional...<br>- - `#4219 <<a href="https://github.com/scipy/scipy/pull/4219">https://github.com/scipy/scipy/pull/4219</a>>`__: DOC: silence several Sphinx warnings when building the docs<br>- - `#4223 <<a href="https://github.com/scipy/scipy/pull/4223">https://github.com/scipy/scipy/pull/4223</a>>`__: MAINT: remove two redundant lines of code<br>- - `#4226 <<a href="https://github.com/scipy/scipy/pull/4226">https://github.com/scipy/scipy/pull/4226</a>>`__: try forcing the numpy rebuild with relaxed strides<br>- - `#4228 <<a href="https://github.com/scipy/scipy/pull/4228">https://github.com/scipy/scipy/pull/4228</a>>`__: BLD: some updates to Bento config files and docs. Closes gh-3978.<br>- - `#4232 <<a href="https://github.com/scipy/scipy/pull/4232">https://github.com/scipy/scipy/pull/4232</a>>`__: wrong references in the docs<br>- - `#4242 <<a href="https://github.com/scipy/scipy/pull/4242">https://github.com/scipy/scipy/pull/4242</a>>`__: DOC: change example sample spacing<br>- - `#4245 <<a href="https://github.com/scipy/scipy/pull/4245">https://github.com/scipy/scipy/pull/4245</a>>`__: Arff fixes<br>- - `#4246 <<a href="https://github.com/scipy/scipy/pull/4246">https://github.com/scipy/scipy/pull/4246</a>>`__: MAINT: C fixes<br>- - `#4247 <<a href="https://github.com/scipy/scipy/pull/4247">https://github.com/scipy/scipy/pull/4247</a>>`__: MAINT: remove some unused code<br>- - `#4249 <<a href="https://github.com/scipy/scipy/pull/4249">https://github.com/scipy/scipy/pull/4249</a>>`__: Add routines for updating QR decompositions<br>- - `#4250 <<a href="https://github.com/scipy/scipy/pull/4250">https://github.com/scipy/scipy/pull/4250</a>>`__: MAINT: Some pyflakes-driven cleanup in linalg and sparse<br>- - `#4252 <<a href="https://github.com/scipy/scipy/pull/4252">https://github.com/scipy/scipy/pull/4252</a>>`__: MAINT trim away >10 kLOC of generated C code<br>- - `#4253 <<a href="https://github.com/scipy/scipy/pull/4253">https://github.com/scipy/scipy/pull/4253</a>>`__: TST: stop shadowing ellip* tests vs boost data<br>- - `#4254 <<a href="https://github.com/scipy/scipy/pull/4254">https://github.com/scipy/scipy/pull/4254</a>>`__: MAINT: special: use NPY_PI, not M_PI<br>- - `#4255 <<a href="https://github.com/scipy/scipy/pull/4255">https://github.com/scipy/scipy/pull/4255</a>>`__: DOC: INSTALL: use Py3-compatible print syntax, and don't mention...<br>- - `#4256 <<a href="https://github.com/scipy/scipy/pull/4256">https://github.com/scipy/scipy/pull/4256</a>>`__: ENH: spatial: reimplement cdist_cosine using np.dot<br>- - `#4258 <<a href="https://github.com/scipy/scipy/pull/4258">https://github.com/scipy/scipy/pull/4258</a>>`__: BUG: io.arff #4429 #2088<br>- - `#4261 <<a href="https://github.com/scipy/scipy/pull/4261">https://github.com/scipy/scipy/pull/4261</a>>`__: MAINT: signal: PEP8 and related style clean up.<br>- - `#4262 <<a href="https://github.com/scipy/scipy/pull/4262">https://github.com/scipy/scipy/pull/4262</a>>`__: BUG: newton_krylov() was ignoring norm_tol argument, closes #4259<br>- - `#4263 <<a href="https://github.com/scipy/scipy/pull/4263">https://github.com/scipy/scipy/pull/4263</a>>`__: MAINT: clean up test noise and optimize tests for docstrings...<br>- - `#4266 <<a href="https://github.com/scipy/scipy/pull/4266">https://github.com/scipy/scipy/pull/4266</a>>`__: MAINT: io: Give an informative error when attempting to read...<br>- - `#4268 <<a href="https://github.com/scipy/scipy/pull/4268">https://github.com/scipy/scipy/pull/4268</a>>`__: MAINT: fftpack benchmark integer division vs true division<br>- - `#4269 <<a href="https://github.com/scipy/scipy/pull/4269">https://github.com/scipy/scipy/pull/4269</a>>`__: MAINT: avoid shadowing the eigvals function<br>- - `#4272 <<a href="https://github.com/scipy/scipy/pull/4272">https://github.com/scipy/scipy/pull/4272</a>>`__: BUG: sparse: Fix bench_sparse.py<br>- - `#4276 <<a href="https://github.com/scipy/scipy/pull/4276">https://github.com/scipy/scipy/pull/4276</a>>`__: DOC: remove confusing parts of the documentation related to writing...<br>- - `#4281 <<a href="https://github.com/scipy/scipy/pull/4281">https://github.com/scipy/scipy/pull/4281</a>>`__: Sparse matrix multiplication: only convert array if needed (with...<br>- - `#4284 <<a href="https://github.com/scipy/scipy/pull/4284">https://github.com/scipy/scipy/pull/4284</a>>`__: BUG: integrate: odeint crashed when the integration time was...<br>- - `#4286 <<a href="https://github.com/scipy/scipy/pull/4286">https://github.com/scipy/scipy/pull/4286</a>>`__: MRG: fix matlab output type of logical array<br>- - `#4287 <<a href="https://github.com/scipy/scipy/pull/4287">https://github.com/scipy/scipy/pull/4287</a>>`__: DEP: deprecate stats.pdf_fromgamma. Closes gh-699.<br>- - `#4291 <<a href="https://github.com/scipy/scipy/pull/4291">https://github.com/scipy/scipy/pull/4291</a>>`__: DOC: linalg: fix layout in cholesky_banded docstring<br>- - `#4292 <<a href="https://github.com/scipy/scipy/pull/4292">https://github.com/scipy/scipy/pull/4292</a>>`__: BUG: allow empty dict as proxy for empty struct<br>- - `#4293 <<a href="https://github.com/scipy/scipy/pull/4293">https://github.com/scipy/scipy/pull/4293</a>>`__: MAINT: != -> not_equal in hamming distance implementation<br>- - `#4295 <<a href="https://github.com/scipy/scipy/pull/4295">https://github.com/scipy/scipy/pull/4295</a>>`__: Pole placement<br>- - `#4296 <<a href="https://github.com/scipy/scipy/pull/4296">https://github.com/scipy/scipy/pull/4296</a>>`__: MAINT: some cleanups in tests of several modules<br>- - `#4302 <<a href="https://github.com/scipy/scipy/pull/4302">https://github.com/scipy/scipy/pull/4302</a>>`__: ENH: Solve toeplitz linear systems<br>- - `#4306 <<a href="https://github.com/scipy/scipy/pull/4306">https://github.com/scipy/scipy/pull/4306</a>>`__: Add benchmark for conjugate gradient solver.<br>- - `#4307 <<a href="https://github.com/scipy/scipy/pull/4307">https://github.com/scipy/scipy/pull/4307</a>>`__: BLD: PEP 440<br>- - `#4310 <<a href="https://github.com/scipy/scipy/pull/4310">https://github.com/scipy/scipy/pull/4310</a>>`__: BUG: make stats.geom.logpmf(1,1) return 0.0 instead of nan<br>- - `#4311 <<a href="https://github.com/scipy/scipy/pull/4311">https://github.com/scipy/scipy/pull/4311</a>>`__: TST: restore a test that uses slogdet now that we have dropped...<br>- - `#4313 <<a href="https://github.com/scipy/scipy/pull/4313">https://github.com/scipy/scipy/pull/4313</a>>`__: Some minor fixes for stats.wishart addition.<br>- - `#4315 <<a href="https://github.com/scipy/scipy/pull/4315">https://github.com/scipy/scipy/pull/4315</a>>`__: MAINT: drop numpy 1.5 compatibility code in sparse matrix tests<br>- - `#4318 <<a href="https://github.com/scipy/scipy/pull/4318">https://github.com/scipy/scipy/pull/4318</a>>`__: ENH: Add random_state to multivariate distributions<br>- - `#4319 <<a href="https://github.com/scipy/scipy/pull/4319">https://github.com/scipy/scipy/pull/4319</a>>`__: MAINT: fix hamming distance regression for exotic arrays, with...<br>- - `#4320 <<a href="https://github.com/scipy/scipy/pull/4320">https://github.com/scipy/scipy/pull/4320</a>>`__: TST: a few changes like self.assertTrue(x == y, message) -> assert_equal(x,...<br>- - `#4321 <<a href="https://github.com/scipy/scipy/pull/4321">https://github.com/scipy/scipy/pull/4321</a>>`__: TST: more changes like self.assertTrue(x == y, message) -> assert_equal(x,...<br>- - `#4322 <<a href="https://github.com/scipy/scipy/pull/4322">https://github.com/scipy/scipy/pull/4322</a>>`__: TST: in test_signaltools, changes like self.assertTrue(x == y,...<br>- - `#4323 <<a href="https://github.com/scipy/scipy/pull/4323">https://github.com/scipy/scipy/pull/4323</a>>`__: MAINT: clean up benchmarks so they can all be run as single files.<br>- - `#4324 <<a href="https://github.com/scipy/scipy/pull/4324">https://github.com/scipy/scipy/pull/4324</a>>`__: Add more detailed committer guidelines, update MAINTAINERS.txt<br>- - `#4326 <<a href="https://github.com/scipy/scipy/pull/4326">https://github.com/scipy/scipy/pull/4326</a>>`__: TST: use numpy.testing in test_hierarchy.py<br>- - `#4329 <<a href="https://github.com/scipy/scipy/pull/4329">https://github.com/scipy/scipy/pull/4329</a>>`__: MAINT: stats: rename check_random_state test function<br>- - `#4330 <<a href="https://github.com/scipy/scipy/pull/4330">https://github.com/scipy/scipy/pull/4330</a>>`__: Update distance tests<br>- - `#4333 <<a href="https://github.com/scipy/scipy/pull/4333">https://github.com/scipy/scipy/pull/4333</a>>`__: MAINT: import comb, factorial from scipy.special, not scipy.misc<br>- - `#4338 <<a href="https://github.com/scipy/scipy/pull/4338">https://github.com/scipy/scipy/pull/4338</a>>`__: TST: more conversions from nose to numpy.testing<br>- - `#4339 <<a href="https://github.com/scipy/scipy/pull/4339">https://github.com/scipy/scipy/pull/4339</a>>`__: MAINT: remove the deprecated all_mat function from special_matrices.py<br>- - `#4340 <<a href="https://github.com/scipy/scipy/pull/4340">https://github.com/scipy/scipy/pull/4340</a>>`__: add several features to frozen distributions<br>- - `#4344 <<a href="https://github.com/scipy/scipy/pull/4344">https://github.com/scipy/scipy/pull/4344</a>>`__: BUG: Fix/test invalid lwork param in qr<br>- - `#4345 <<a href="https://github.com/scipy/scipy/pull/4345">https://github.com/scipy/scipy/pull/4345</a>>`__: Fix test noise visible with Python 3.x<br>- - `#4347 <<a href="https://github.com/scipy/scipy/pull/4347">https://github.com/scipy/scipy/pull/4347</a>>`__: Remove deprecated blas/lapack imports, rename lib to _lib<br>- - `#4349 <<a href="https://github.com/scipy/scipy/pull/4349">https://github.com/scipy/scipy/pull/4349</a>>`__: DOC: add a nontrivial example to stats.binned_statistic.<br>- - `#4350 <<a href="https://github.com/scipy/scipy/pull/4350">https://github.com/scipy/scipy/pull/4350</a>>`__: MAINT: remove optimize.anneal for 0.16.0 (was deprecated in 0.14.0).<br>- - `#4351 <<a href="https://github.com/scipy/scipy/pull/4351">https://github.com/scipy/scipy/pull/4351</a>>`__: MAINT: fix usage of deprecated Numpy C API in optimize...<br>- - `#4352 <<a href="https://github.com/scipy/scipy/pull/4352">https://github.com/scipy/scipy/pull/4352</a>>`__: MAINT: fix a number of special test failures<br>- - `#4353 <<a href="https://github.com/scipy/scipy/pull/4353">https://github.com/scipy/scipy/pull/4353</a>>`__: implement cdf for betaprime distribution<br>- - `#4357 <<a href="https://github.com/scipy/scipy/pull/4357">https://github.com/scipy/scipy/pull/4357</a>>`__: BUG: piecewise polynomial antiderivative<br>- - `#4358 <<a href="https://github.com/scipy/scipy/pull/4358">https://github.com/scipy/scipy/pull/4358</a>>`__: BUG: integrate: fix handling of banded Jacobians in odeint, plus...<br>- - `#4359 <<a href="https://github.com/scipy/scipy/pull/4359">https://github.com/scipy/scipy/pull/4359</a>>`__: MAINT: remove a code path taken for Python version < 2.5<br>- - `#4360 <<a href="https://github.com/scipy/scipy/pull/4360">https://github.com/scipy/scipy/pull/4360</a>>`__: MAINT: stats.mstats: Remove some unused variables (thanks, pyflakes).<br>- - `#4362 <<a href="https://github.com/scipy/scipy/pull/4362">https://github.com/scipy/scipy/pull/4362</a>>`__: Removed erroneous reference to smoothing parameter #4072<br>- - `#4363 <<a href="https://github.com/scipy/scipy/pull/4363">https://github.com/scipy/scipy/pull/4363</a>>`__: MAINT: interpolate: clean up in fitpack.py<br>- - `#4364 <<a href="https://github.com/scipy/scipy/pull/4364">https://github.com/scipy/scipy/pull/4364</a>>`__: MAINT: lib: don't export "partial" from decorator<br>- - `#4365 <<a href="https://github.com/scipy/scipy/pull/4365">https://github.com/scipy/scipy/pull/4365</a>>`__: svdvals now returns a length-0 sequence of singular values given...<br>- - `#4367 <<a href="https://github.com/scipy/scipy/pull/4367">https://github.com/scipy/scipy/pull/4367</a>>`__: DOC: slightly improve TeX rendering of wishart/invwishart docstring<br>- - `#4373 <<a href="https://github.com/scipy/scipy/pull/4373">https://github.com/scipy/scipy/pull/4373</a>>`__: ENH: wrap gtsv and ptsv for solve_banded and solveh_banded.<br>- - `#4374 <<a href="https://github.com/scipy/scipy/pull/4374">https://github.com/scipy/scipy/pull/4374</a>>`__: ENH: Enhancements to spatial.cKDTree<br>- - `#4376 <<a href="https://github.com/scipy/scipy/pull/4376">https://github.com/scipy/scipy/pull/4376</a>>`__: BF: fix reading off-spec matlab logical sparse<br>- - `#4377 <<a href="https://github.com/scipy/scipy/pull/4377">https://github.com/scipy/scipy/pull/4377</a>>`__: MAINT: integrate: Clean up some Fortran test code.<br>- - `#4378 <<a href="https://github.com/scipy/scipy/pull/4378">https://github.com/scipy/scipy/pull/4378</a>>`__: MAINT: fix usage of deprecated Numpy C API in signal<br>- - `#4380 <<a href="https://github.com/scipy/scipy/pull/4380">https://github.com/scipy/scipy/pull/4380</a>>`__: MAINT: scipy.optimize, removing further anneal references<br>- - `#4381 <<a href="https://github.com/scipy/scipy/pull/4381">https://github.com/scipy/scipy/pull/4381</a>>`__: ENH: Make DCT and DST accept int and complex types like fft<br>- - `#4392 <<a href="https://github.com/scipy/scipy/pull/4392">https://github.com/scipy/scipy/pull/4392</a>>`__: ENH: optimize: add DF-SANE nonlinear derivative-free solver<br>- - `#4394 <<a href="https://github.com/scipy/scipy/pull/4394">https://github.com/scipy/scipy/pull/4394</a>>`__: Make reordering algorithms 64-bit clean<br>- - `#4396 <<a href="https://github.com/scipy/scipy/pull/4396">https://github.com/scipy/scipy/pull/4396</a>>`__: BUG: bundle cblas.h in Accelerate ABI wrappers to enable compilation...<br>- - `#4398 <<a href="https://github.com/scipy/scipy/pull/4398">https://github.com/scipy/scipy/pull/4398</a>>`__: FIX pdist bug where wminkowski's w.dtype != double<br>- - `#4402 <<a href="https://github.com/scipy/scipy/pull/4402">https://github.com/scipy/scipy/pull/4402</a>>`__: BUG: fix stat.hypergeom argcheck<br>- - `#4404 <<a href="https://github.com/scipy/scipy/pull/4404">https://github.com/scipy/scipy/pull/4404</a>>`__: MAINT: Fill in the full symmetric squareform in the C loop<br>- - `#4405 <<a href="https://github.com/scipy/scipy/pull/4405">https://github.com/scipy/scipy/pull/4405</a>>`__: BUG: avoid X += X.T (refs #4401)<br>- - `#4407 <<a href="https://github.com/scipy/scipy/pull/4407">https://github.com/scipy/scipy/pull/4407</a>>`__: improved accuracy of gompertz distribution for small x<br>- - `#4414 <<a href="https://github.com/scipy/scipy/pull/4414">https://github.com/scipy/scipy/pull/4414</a>>`__: DOC:fix error in scipy.signal.cwt documentation.<br>- - `#4415 <<a href="https://github.com/scipy/scipy/pull/4415">https://github.com/scipy/scipy/pull/4415</a>>`__: ENH: Improve accuracy of lomax for small x.<br>- - `#4416 <<a href="https://github.com/scipy/scipy/pull/4416">https://github.com/scipy/scipy/pull/4416</a>>`__: DOC: correct a parameter name in docstring of SuperLU.solve....<br>- - `#4419 <<a href="https://github.com/scipy/scipy/pull/4419">https://github.com/scipy/scipy/pull/4419</a>>`__: Restore scipy.linalg.calc_lwork also in master<br>- - `#4420 <<a href="https://github.com/scipy/scipy/pull/4420">https://github.com/scipy/scipy/pull/4420</a>>`__: fix a performance issue with a sparse solver<br>- - `#4423 <<a href="https://github.com/scipy/scipy/pull/4423">https://github.com/scipy/scipy/pull/4423</a>>`__: ENH: improve rayleigh accuracy for large x.<br>- - `#4424 <<a href="https://github.com/scipy/scipy/pull/4424">https://github.com/scipy/scipy/pull/4424</a>>`__: BUG: optimize.minimize: fix overflow issue with integer x0 input.<br>- - `#4425 <<a href="https://github.com/scipy/scipy/pull/4425">https://github.com/scipy/scipy/pull/4425</a>>`__: ENH: Improve accuracy of truncexpon for small x<br>- - `#4426 <<a href="https://github.com/scipy/scipy/pull/4426">https://github.com/scipy/scipy/pull/4426</a>>`__: ENH: improve rayleigh accuracy for large x.<br>- - `#4427 <<a href="https://github.com/scipy/scipy/pull/4427">https://github.com/scipy/scipy/pull/4427</a>>`__: MAINT: optimize: cleanup of TNC code<br>- - `#4429 <<a href="https://github.com/scipy/scipy/pull/4429">https://github.com/scipy/scipy/pull/4429</a>>`__: BLD: fix build failure with numpy 1.7.x and 1.8.x.<br>- - `#4430 <<a href="https://github.com/scipy/scipy/pull/4430">https://github.com/scipy/scipy/pull/4430</a>>`__: BUG: fix a sparse.dok_matrix set/get copy-paste bug<br>- - `#4433 <<a href="https://github.com/scipy/scipy/pull/4433">https://github.com/scipy/scipy/pull/4433</a>>`__: Update _minimize.py<br>- - `#4435 <<a href="https://github.com/scipy/scipy/pull/4435">https://github.com/scipy/scipy/pull/4435</a>>`__: ENH: release GIL around batch distance computations<br>- - `#4436 <<a href="https://github.com/scipy/scipy/pull/4436">https://github.com/scipy/scipy/pull/4436</a>>`__: Fixed incomplete documentation for spsolve<br>- - `#4439 <<a href="https://github.com/scipy/scipy/pull/4439">https://github.com/scipy/scipy/pull/4439</a>>`__: MAINT: integrate: Some clean up in the tests.<br>- - `#4440 <<a href="https://github.com/scipy/scipy/pull/4440">https://github.com/scipy/scipy/pull/4440</a>>`__: Fast permutation t-test<br>- - `#4442 <<a href="https://github.com/scipy/scipy/pull/4442">https://github.com/scipy/scipy/pull/4442</a>>`__: DOC: optimize: fix wrong result in docstring<br>- - `#4447 <<a href="https://github.com/scipy/scipy/pull/4447">https://github.com/scipy/scipy/pull/4447</a>>`__: DOC: signal: Some additional documentation to go along with the...<br>- - `#4448 <<a href="https://github.com/scipy/scipy/pull/4448">https://github.com/scipy/scipy/pull/4448</a>>`__: DOC: tweak the docstring of lapack.linalg module<br>- - `#4449 <<a href="https://github.com/scipy/scipy/pull/4449">https://github.com/scipy/scipy/pull/4449</a>>`__: fix a typo in the expit docstring<br>- - `#4451 <<a href="https://github.com/scipy/scipy/pull/4451">https://github.com/scipy/scipy/pull/4451</a>>`__: ENH: vectorize distance loops with gcc<br>- - `#4456 <<a href="https://github.com/scipy/scipy/pull/4456">https://github.com/scipy/scipy/pull/4456</a>>`__: MAINT: don't fail large data tests on MemoryError<br>- - `#4461 <<a href="https://github.com/scipy/scipy/pull/4461">https://github.com/scipy/scipy/pull/4461</a>>`__: CI: use travis_retry to deal with network timeouts<br>- - `#4462 <<a href="https://github.com/scipy/scipy/pull/4462">https://github.com/scipy/scipy/pull/4462</a>>`__: DOC: rationalize minimize() et al. documentation<br>- - `#4470 <<a href="https://github.com/scipy/scipy/pull/4470">https://github.com/scipy/scipy/pull/4470</a>>`__: MAINT: sparse: inherit dok_matrix.toarray from spmatrix<br>- - `#4473 <<a href="https://github.com/scipy/scipy/pull/4473">https://github.com/scipy/scipy/pull/4473</a>>`__: BUG: signal: Fix validation of the zi shape in sosfilt.<br>- - `#4475 <<a href="https://github.com/scipy/scipy/pull/4475">https://github.com/scipy/scipy/pull/4475</a>>`__: BLD: setup.py: update min numpy version and support "setup.py...<br>- - `#4481 <<a href="https://github.com/scipy/scipy/pull/4481">https://github.com/scipy/scipy/pull/4481</a>>`__: ENH: add a new linalg special matrix: the Helmert matrix<br>- - `#4485 <<a href="https://github.com/scipy/scipy/pull/4485">https://github.com/scipy/scipy/pull/4485</a>>`__: MRG: some changes to allow reading bad mat files<br>- - `#4490 <<a href="https://github.com/scipy/scipy/pull/4490">https://github.com/scipy/scipy/pull/4490</a>>`__: [ENH] linalg.hessenberg: use orghr - rebase<br>- - `#4491 <<a href="https://github.com/scipy/scipy/pull/4491">https://github.com/scipy/scipy/pull/4491</a>>`__: ENH: linalg: Adding wrapper for potentially useful LAPACK function...<br>- - `#4493 <<a href="https://github.com/scipy/scipy/pull/4493">https://github.com/scipy/scipy/pull/4493</a>>`__: BENCH: the solve_toeplitz benchmark used outdated syntax and...<br>- - `#4494 <<a href="https://github.com/scipy/scipy/pull/4494">https://github.com/scipy/scipy/pull/4494</a>>`__: MAINT: stats: remove duplicated code<br>- - `#4496 <<a href="https://github.com/scipy/scipy/pull/4496">https://github.com/scipy/scipy/pull/4496</a>>`__: References added for watershed_ift algorithm<br>- - `#4499 <<a href="https://github.com/scipy/scipy/pull/4499">https://github.com/scipy/scipy/pull/4499</a>>`__: DOC: reshuffle stats distributions documentation<br>- - `#4501 <<a href="https://github.com/scipy/scipy/pull/4501">https://github.com/scipy/scipy/pull/4501</a>>`__: Replace benchmark suite with airspeed velocity<br>- - `#4502 <<a href="https://github.com/scipy/scipy/pull/4502">https://github.com/scipy/scipy/pull/4502</a>>`__: SLSQP should strictly satisfy bound constraints<br>- - `#4503 <<a href="https://github.com/scipy/scipy/pull/4503">https://github.com/scipy/scipy/pull/4503</a>>`__: DOC: forward port 0.15.x release notes and update author name...<br>- - `#4504 <<a href="https://github.com/scipy/scipy/pull/4504">https://github.com/scipy/scipy/pull/4504</a>>`__: ENH: option to avoid computing possibly unused svd matrix<br>- - `#4505 <<a href="https://github.com/scipy/scipy/pull/4505">https://github.com/scipy/scipy/pull/4505</a>>`__: Rebase of PR 3303 (sparse matrix norms)<br>- - `#4507 <<a href="https://github.com/scipy/scipy/pull/4507">https://github.com/scipy/scipy/pull/4507</a>>`__: MAINT: fix lobpcg performance regression<br>- - `#4509 <<a href="https://github.com/scipy/scipy/pull/4509">https://github.com/scipy/scipy/pull/4509</a>>`__: DOC: sparse: replace dead link<br>- - `#4511 <<a href="https://github.com/scipy/scipy/pull/4511">https://github.com/scipy/scipy/pull/4511</a>>`__: Fixed differential evolution bug<br>- - `#4512 <<a href="https://github.com/scipy/scipy/pull/4512">https://github.com/scipy/scipy/pull/4512</a>>`__: Change to fully PEP440 compliant dev version numbers (always...<br>- - `#4525 <<a href="https://github.com/scipy/scipy/pull/4525">https://github.com/scipy/scipy/pull/4525</a>>`__: made tiny style corrections (pep8)<br>- - `#4533 <<a href="https://github.com/scipy/scipy/pull/4533">https://github.com/scipy/scipy/pull/4533</a>>`__: Add exponentially modified gaussian distribution (scipy.stats.expongauss)<br>- - `#4534 <<a href="https://github.com/scipy/scipy/pull/4534">https://github.com/scipy/scipy/pull/4534</a>>`__: MAINT: benchmarks: make benchmark suite importable on all scipy...<br>- - `#4535 <<a href="https://github.com/scipy/scipy/pull/4535">https://github.com/scipy/scipy/pull/4535</a>>`__: BUG: Changed zip() to list(zip()) so that it could work in Python...<br>- - `#4536 <<a href="https://github.com/scipy/scipy/pull/4536">https://github.com/scipy/scipy/pull/4536</a>>`__: Follow up to pr 4348 (exponential window)<br>- - `#4540 <<a href="https://github.com/scipy/scipy/pull/4540">https://github.com/scipy/scipy/pull/4540</a>>`__: ENH: spatial: Add procrustes analysis<br>- - `#4541 <<a href="https://github.com/scipy/scipy/pull/4541">https://github.com/scipy/scipy/pull/4541</a>>`__: Bench fixes<br>- - `#4542 <<a href="https://github.com/scipy/scipy/pull/4542">https://github.com/scipy/scipy/pull/4542</a>>`__: TST: NumpyVersion dev -> dev0<br>- - `#4543 <<a href="https://github.com/scipy/scipy/pull/4543">https://github.com/scipy/scipy/pull/4543</a>>`__: BUG: Overflow in savgol_coeffs<br>- - `#4544 <<a href="https://github.com/scipy/scipy/pull/4544">https://github.com/scipy/scipy/pull/4544</a>>`__: pep8 fixes for stats<br>- - `#4546 <<a href="https://github.com/scipy/scipy/pull/4546">https://github.com/scipy/scipy/pull/4546</a>>`__: MAINT: use reduction axis arguments in one-norm estimation<br>- - `#4549 <<a href="https://github.com/scipy/scipy/pull/4549">https://github.com/scipy/scipy/pull/4549</a>>`__: ENH : Added group_delay to scipy.signal<br>- - `#4553 <<a href="https://github.com/scipy/scipy/pull/4553">https://github.com/scipy/scipy/pull/4553</a>>`__: ENH: Significantly faster moment function<br>- - `#4556 <<a href="https://github.com/scipy/scipy/pull/4556">https://github.com/scipy/scipy/pull/4556</a>>`__: DOC: document the changes of the sparse.linalg.svds (optional...<br>- - `#4559 <<a href="https://github.com/scipy/scipy/pull/4559">https://github.com/scipy/scipy/pull/4559</a>>`__: DOC: stats: describe loc and scale parameters in the docstring...<br>- - `#4563 <<a href="https://github.com/scipy/scipy/pull/4563">https://github.com/scipy/scipy/pull/4563</a>>`__: ENH: rewrite of stats.ppcc_plot<br>- - `#4564 <<a href="https://github.com/scipy/scipy/pull/4564">https://github.com/scipy/scipy/pull/4564</a>>`__: Be more (or less) forgiving when user passes +-inf instead of...<br>- - `#4566 <<a href="https://github.com/scipy/scipy/pull/4566">https://github.com/scipy/scipy/pull/4566</a>>`__: DEP: remove a bunch of deprecated function from scipy.stats,...<br>- - `#4570 <<a href="https://github.com/scipy/scipy/pull/4570">https://github.com/scipy/scipy/pull/4570</a>>`__: MNT: Suppress LineSearchWarning's in scipy.optimize tests<br>- - `#4572 <<a href="https://github.com/scipy/scipy/pull/4572">https://github.com/scipy/scipy/pull/4572</a>>`__: ENH: Extract inverse hessian information from L-BFGS-B<br>- - `#4576 <<a href="https://github.com/scipy/scipy/pull/4576">https://github.com/scipy/scipy/pull/4576</a>>`__: ENH: Split signal.lti into subclasses, part of #2912<br>- - `#4578 <<a href="https://github.com/scipy/scipy/pull/4578">https://github.com/scipy/scipy/pull/4578</a>>`__: MNT: Reconcile docstrings and function signatures<br>- - `#4581 <<a href="https://github.com/scipy/scipy/pull/4581">https://github.com/scipy/scipy/pull/4581</a>>`__: Fix build with Intel MKL on Linux<br>- - `#4583 <<a href="https://github.com/scipy/scipy/pull/4583">https://github.com/scipy/scipy/pull/4583</a>>`__: DOC: optimize: remove references to unused disp kwarg<br>- - `#4584 <<a href="https://github.com/scipy/scipy/pull/4584">https://github.com/scipy/scipy/pull/4584</a>>`__: ENH: scipy.signal - Tukey window<br>- - `#4587 <<a href="https://github.com/scipy/scipy/pull/4587">https://github.com/scipy/scipy/pull/4587</a>>`__: Hermite asymptotic<br>- - `#4593 <<a href="https://github.com/scipy/scipy/pull/4593">https://github.com/scipy/scipy/pull/4593</a>>`__: DOC - add example to RegularGridInterpolator<br>- - `#4595 <<a href="https://github.com/scipy/scipy/pull/4595">https://github.com/scipy/scipy/pull/4595</a>>`__: DOC: Fix erroneous latex characters in tutorial/optimize.<br>- - `#4600 <<a href="https://github.com/scipy/scipy/pull/4600">https://github.com/scipy/scipy/pull/4600</a>>`__: Add return codes to optimize.tnc docs<br>- - `#4603 <<a href="https://github.com/scipy/scipy/pull/4603">https://github.com/scipy/scipy/pull/4603</a>>`__: ENH: Wrap LAPACK ``*lange`` functions for matrix norms<br>- - `#4604 <<a href="https://github.com/scipy/scipy/pull/4604">https://github.com/scipy/scipy/pull/4604</a>>`__: scipy.stats: generalized normal distribution<br>- - `#4609 <<a href="https://github.com/scipy/scipy/pull/4609">https://github.com/scipy/scipy/pull/4609</a>>`__: MAINT: interpolate: fix a few inconsistencies between docstrings...<br>- - `#4610 <<a href="https://github.com/scipy/scipy/pull/4610">https://github.com/scipy/scipy/pull/4610</a>>`__: MAINT: make runtest.py --bench-compare use asv continuous and...<br>- - `#4611 <<a href="https://github.com/scipy/scipy/pull/4611">https://github.com/scipy/scipy/pull/4611</a>>`__: DOC: stats: explain rice scaling; add a note to the tutorial...<br>- - `#4614 <<a href="https://github.com/scipy/scipy/pull/4614">https://github.com/scipy/scipy/pull/4614</a>>`__: BUG: lfilter, the size of zi was not checked correctly for nd...<br>- - `#4617 <<a href="https://github.com/scipy/scipy/pull/4617">https://github.com/scipy/scipy/pull/4617</a>>`__: MAINT: integrate: Clean the C code behind odeint.<br>- - `#4618 <<a href="https://github.com/scipy/scipy/pull/4618">https://github.com/scipy/scipy/pull/4618</a>>`__: FIX: Raise error when window length != data length<br>- - `#4619 <<a href="https://github.com/scipy/scipy/pull/4619">https://github.com/scipy/scipy/pull/4619</a>>`__: Issue #4550: `scipy.stats.mode` - UnboundLocalError on empty...<br>- - `#4620 <<a href="https://github.com/scipy/scipy/pull/4620">https://github.com/scipy/scipy/pull/4620</a>>`__: Fixed a problem (#4590) with svds accepting wrong eigenvalue...<br>- - `#4621 <<a href="https://github.com/scipy/scipy/pull/4621">https://github.com/scipy/scipy/pull/4621</a>>`__: Speed up special.ai_zeros/bi_zeros by 10x<br>- - `#4623 <<a href="https://github.com/scipy/scipy/pull/4623">https://github.com/scipy/scipy/pull/4623</a>>`__: MAINT: some tweaks to spatial.procrustes (private file, html...<br>- - `#4628 <<a href="https://github.com/scipy/scipy/pull/4628">https://github.com/scipy/scipy/pull/4628</a>>`__: Speed up signal.lfilter and add a convolution path for FIR filters<br>- - `#4629 <<a href="https://github.com/scipy/scipy/pull/4629">https://github.com/scipy/scipy/pull/4629</a>>`__: Bug: integrate.nquad; resolve issue #4599<br>- - `#4631 <<a href="https://github.com/scipy/scipy/pull/4631">https://github.com/scipy/scipy/pull/4631</a>>`__: MAINT: integrate: Remove unused variables in a Fortran test function.<br>- - `#4633 <<a href="https://github.com/scipy/scipy/pull/4633">https://github.com/scipy/scipy/pull/4633</a>>`__: MAINT: Fix convergence message for remez<br>- - `#4635 <<a href="https://github.com/scipy/scipy/pull/4635">https://github.com/scipy/scipy/pull/4635</a>>`__: PEP8: indentation (so that pep8 bot does not complain)<br>- - `#4637 <<a href="https://github.com/scipy/scipy/pull/4637">https://github.com/scipy/scipy/pull/4637</a>>`__: MAINT: generalize a sign function to do the right thing for complex...<br>- - `#4639 <<a href="https://github.com/scipy/scipy/pull/4639">https://github.com/scipy/scipy/pull/4639</a>>`__: Amended typo in apple_sgemv_fix.c<br>- - `#4642 <<a href="https://github.com/scipy/scipy/pull/4642">https://github.com/scipy/scipy/pull/4642</a>>`__: MAINT: use lapack for scipy.linalg.norm<br>- - `#4643 <<a href="https://github.com/scipy/scipy/pull/4643">https://github.com/scipy/scipy/pull/4643</a>>`__: RBF default epsilon too large 2020<br>- - `#4646 <<a href="https://github.com/scipy/scipy/pull/4646">https://github.com/scipy/scipy/pull/4646</a>>`__: Added atleast_1d around poly in invres and invresz<br>- - `#4647 <<a href="https://github.com/scipy/scipy/pull/4647">https://github.com/scipy/scipy/pull/4647</a>>`__: fix doc pdf build<br>- - `#4648 <<a href="https://github.com/scipy/scipy/pull/4648">https://github.com/scipy/scipy/pull/4648</a>>`__: BUG: Fixes #4408: Vector-valued constraints in minimize() et...<br>- - `#4649 <<a href="https://github.com/scipy/scipy/pull/4649">https://github.com/scipy/scipy/pull/4649</a>>`__: Vonmisesfix<br>- - `#4650 <<a href="https://github.com/scipy/scipy/pull/4650">https://github.com/scipy/scipy/pull/4650</a>>`__: Signal example clean up in Tukey and place_poles<br>- - `#4652 <<a href="https://github.com/scipy/scipy/pull/4652">https://github.com/scipy/scipy/pull/4652</a>>`__: DOC: Fix the error in convolve for same mode<br>- - `#4653 <<a href="https://github.com/scipy/scipy/pull/4653">https://github.com/scipy/scipy/pull/4653</a>>`__: improve erf performance<br>- - `#4655 <<a href="https://github.com/scipy/scipy/pull/4655">https://github.com/scipy/scipy/pull/4655</a>>`__: DEP: deprecate scipy.stats.histogram2 in favour of np.histogram2d<br>- - `#4656 <<a href="https://github.com/scipy/scipy/pull/4656">https://github.com/scipy/scipy/pull/4656</a>>`__: DEP: deprecate scipy.stats.signaltonoise<br>- - `#4660 <<a href="https://github.com/scipy/scipy/pull/4660">https://github.com/scipy/scipy/pull/4660</a>>`__: Avoid extra copy for sparse compressed [:, seq] and [seq, :]...<br>- - `#4661 <<a href="https://github.com/scipy/scipy/pull/4661">https://github.com/scipy/scipy/pull/4661</a>>`__: Clean, rebase of #4478, adding ?gelsy and ?gelsd wrappers<br>- - `#4662 <<a href="https://github.com/scipy/scipy/pull/4662">https://github.com/scipy/scipy/pull/4662</a>>`__: MAINT: Correct odeint messages<br>- - `#4664 <<a href="https://github.com/scipy/scipy/pull/4664">https://github.com/scipy/scipy/pull/4664</a>>`__: Update _monotone.py<br>- - `#4672 <<a href="https://github.com/scipy/scipy/pull/4672">https://github.com/scipy/scipy/pull/4672</a>>`__: fix behavior of scipy.linalg.block_diag for empty input<br>- - `#4675 <<a href="https://github.com/scipy/scipy/pull/4675">https://github.com/scipy/scipy/pull/4675</a>>`__: Fix lsim<br>- - `#4676 <<a href="https://github.com/scipy/scipy/pull/4676">https://github.com/scipy/scipy/pull/4676</a>>`__: Added missing colon to :math: directive in docstring.<br>- - `#4679 <<a href="https://github.com/scipy/scipy/pull/4679">https://github.com/scipy/scipy/pull/4679</a>>`__: ENH: sparse randn<br>- - `#4682 <<a href="https://github.com/scipy/scipy/pull/4682">https://github.com/scipy/scipy/pull/4682</a>>`__: ENH: scipy.signal - Addition of CSD, coherence; Enhancement of...<br>- - `#4684 <<a href="https://github.com/scipy/scipy/pull/4684">https://github.com/scipy/scipy/pull/4684</a>>`__: BUG: various errors in weight calculations in orthogonal.py<br>- - `#4685 <<a href="https://github.com/scipy/scipy/pull/4685">https://github.com/scipy/scipy/pull/4685</a>>`__: BUG: Fixes #4594: optimize.linprog IndexError when a callback...<br>- - `#4686 <<a href="https://github.com/scipy/scipy/pull/4686">https://github.com/scipy/scipy/pull/4686</a>>`__: MAINT: cluster: Clean up duplicated exception raising code.<br>- - `#4688 <<a href="https://github.com/scipy/scipy/pull/4688">https://github.com/scipy/scipy/pull/4688</a>>`__: Improve is_distance_dm exception message<br>- - `#4692 <<a href="https://github.com/scipy/scipy/pull/4692">https://github.com/scipy/scipy/pull/4692</a>>`__: MAINT: stats: Simplify the calculation in tukeylambda._ppf<br>- - `#4693 <<a href="https://github.com/scipy/scipy/pull/4693">https://github.com/scipy/scipy/pull/4693</a>>`__: ENH: added functionality to handle scalars in `stats._chk_asarray`<br>- - `#4694 <<a href="https://github.com/scipy/scipy/pull/4694">https://github.com/scipy/scipy/pull/4694</a>>`__: Vectorization of Anderson-Darling computations.<br>- - `#4696 <<a href="https://github.com/scipy/scipy/pull/4696">https://github.com/scipy/scipy/pull/4696</a>>`__: Fix singleton expansion in lfilter.<br>- - `#4698 <<a href="https://github.com/scipy/scipy/pull/4698">https://github.com/scipy/scipy/pull/4698</a>>`__: MAINT: quiet warnings from cephes.<br>- - `#4701 <<a href="https://github.com/scipy/scipy/pull/4701">https://github.com/scipy/scipy/pull/4701</a>>`__: add Bpoly.antiderivatives / integrals<br>- - `#4703 <<a href="https://github.com/scipy/scipy/pull/4703">https://github.com/scipy/scipy/pull/4703</a>>`__: Add citation of published paper<br>- - `#4706 <<a href="https://github.com/scipy/scipy/pull/4706">https://github.com/scipy/scipy/pull/4706</a>>`__: MAINT: special: avoid out-of-bounds access in specfun<br>- - `#4707 <<a href="https://github.com/scipy/scipy/pull/4707">https://github.com/scipy/scipy/pull/4707</a>>`__: MAINT: fix issues with np.matrix as input to functions related...<br>- - `#4709 <<a href="https://github.com/scipy/scipy/pull/4709">https://github.com/scipy/scipy/pull/4709</a>>`__: ENH: `scipy.stats` now returns namedtuples.<br>- - `#4710 <<a href="https://github.com/scipy/scipy/pull/4710">https://github.com/scipy/scipy/pull/4710</a>>`__: scipy.io.idl: make reader more robust to missing variables in...<br>- - `#4711 <<a href="https://github.com/scipy/scipy/pull/4711">https://github.com/scipy/scipy/pull/4711</a>>`__: Fix crash for unknown chunks at the end of file<br>- - `#4712 <<a href="https://github.com/scipy/scipy/pull/4712">https://github.com/scipy/scipy/pull/4712</a>>`__: Reduce onenormest memory usage<br>- - `#4713 <<a href="https://github.com/scipy/scipy/pull/4713">https://github.com/scipy/scipy/pull/4713</a>>`__: MAINT: interpolate: no need to pass dtype around if it can be...<br>- - `#4714 <<a href="https://github.com/scipy/scipy/pull/4714">https://github.com/scipy/scipy/pull/4714</a>>`__: BENCH: Add benchmarks for stats module<br>- - `#4715 <<a href="https://github.com/scipy/scipy/pull/4715">https://github.com/scipy/scipy/pull/4715</a>>`__: MAINT: polish signal.place_poles and signal/test_ltisys.py<br>- - `#4716 <<a href="https://github.com/scipy/scipy/pull/4716">https://github.com/scipy/scipy/pull/4716</a>>`__: DEP: deprecate mstats.signaltonoise ...<br>- - `#4717 <<a href="https://github.com/scipy/scipy/pull/4717">https://github.com/scipy/scipy/pull/4717</a>>`__: MAINT: basinhopping: fix error in tests, silence /0 warning,...<br>- - `#4718 <<a href="https://github.com/scipy/scipy/pull/4718">https://github.com/scipy/scipy/pull/4718</a>>`__: ENH: stats: can specify f-shapes to fix in fitting by name<br>- - `#4721 <<a href="https://github.com/scipy/scipy/pull/4721">https://github.com/scipy/scipy/pull/4721</a>>`__: Document that imresize converts the input to a PIL image<br>- - `#4722 <<a href="https://github.com/scipy/scipy/pull/4722">https://github.com/scipy/scipy/pull/4722</a>>`__: MAINT: PyArray_BASE is not an lvalue unless the deprecated API...<br>- - `#4725 <<a href="https://github.com/scipy/scipy/pull/4725">https://github.com/scipy/scipy/pull/4725</a>>`__: Fix gengamma _nump failure<br>- - `#4728 <<a href="https://github.com/scipy/scipy/pull/4728">https://github.com/scipy/scipy/pull/4728</a>>`__: DOC: add poch to the list of scipy special function descriptions<br>- - `#4735 <<a href="https://github.com/scipy/scipy/pull/4735">https://github.com/scipy/scipy/pull/4735</a>>`__: MAINT: stats: avoid (a spurious) division-by-zero in skew<br>- - `#4738 <<a href="https://github.com/scipy/scipy/pull/4738">https://github.com/scipy/scipy/pull/4738</a>>`__: TST: silence runtime warnings for some corner cases in `stats`...<br>- - `#4739 <<a href="https://github.com/scipy/scipy/pull/4739">https://github.com/scipy/scipy/pull/4739</a>>`__: BLD: try to build numpy instead of using the one on TravisCI<br>- - `#4740 <<a href="https://github.com/scipy/scipy/pull/4740">https://github.com/scipy/scipy/pull/4740</a>>`__: DOC: Update some docstrings with 'versionadded'.<br>- - `#4742 <<a href="https://github.com/scipy/scipy/pull/4742">https://github.com/scipy/scipy/pull/4742</a>>`__: BLD: make sure that relaxed strides checking is in effect on...<br>- - `#4750 <<a href="https://github.com/scipy/scipy/pull/4750">https://github.com/scipy/scipy/pull/4750</a>>`__: DOC: special: TeX typesetting of rel_entr, kl_div and pseudo_huber<br>- - `#4751 <<a href="https://github.com/scipy/scipy/pull/4751">https://github.com/scipy/scipy/pull/4751</a>>`__: BENCH: add sparse null slice benchmark<br>- - `#4753 <<a href="https://github.com/scipy/scipy/pull/4753">https://github.com/scipy/scipy/pull/4753</a>>`__: BUG: Fixed compilation with recent Cython versions.<br>- - `#4756 <<a href="https://github.com/scipy/scipy/pull/4756">https://github.com/scipy/scipy/pull/4756</a>>`__: BUG: Fixes #4733: optimize.brute finish option is not compatible...<br>- - `#4758 <<a href="https://github.com/scipy/scipy/pull/4758">https://github.com/scipy/scipy/pull/4758</a>>`__: DOC: optimize.leastsq default maxfev clarification<br>- - `#4759 <<a href="https://github.com/scipy/scipy/pull/4759">https://github.com/scipy/scipy/pull/4759</a>>`__: improved stats mle fit<br>- - `#4760 <<a href="https://github.com/scipy/scipy/pull/4760">https://github.com/scipy/scipy/pull/4760</a>>`__: MAINT: count bfgs updates more carefully<br>- - `#4762 <<a href="https://github.com/scipy/scipy/pull/4762">https://github.com/scipy/scipy/pull/4762</a>>`__: BUGS: Fixes #4746 and #4594: linprog returns solution violating...<br>- - `#4763 <<a href="https://github.com/scipy/scipy/pull/4763">https://github.com/scipy/scipy/pull/4763</a>>`__: fix small linprog bugs<br>- - `#4766 <<a href="https://github.com/scipy/scipy/pull/4766">https://github.com/scipy/scipy/pull/4766</a>>`__: BENCH: add signal.lsim benchmark<br>- - `#4768 <<a href="https://github.com/scipy/scipy/pull/4768">https://github.com/scipy/scipy/pull/4768</a>>`__: fix python syntax errors in docstring examples<br>- - `#4769 <<a href="https://github.com/scipy/scipy/pull/4769">https://github.com/scipy/scipy/pull/4769</a>>`__: Fixes #4726: test_cobyla.test_vector_constraints<br>- - `#4770 <<a href="https://github.com/scipy/scipy/pull/4770">https://github.com/scipy/scipy/pull/4770</a>>`__: Mark FITPACK functions as thread safe.<br>- - `#4771 <<a href="https://github.com/scipy/scipy/pull/4771">https://github.com/scipy/scipy/pull/4771</a>>`__: edited scipy/stats/stats.py to fix doctest for fisher_exact<br>- - `#4773 <<a href="https://github.com/scipy/scipy/pull/4773">https://github.com/scipy/scipy/pull/4773</a>>`__: DOC: update 0.16.0 release notes.<br>- - `#4775 <<a href="https://github.com/scipy/scipy/pull/4775">https://github.com/scipy/scipy/pull/4775</a>>`__: DOC: linalg: add funm_psd as a docstring example<br>- - `#4778 <<a href="https://github.com/scipy/scipy/pull/4778">https://github.com/scipy/scipy/pull/4778</a>>`__: Use a dictionary for function name synonyms<br>- - `#4780 <<a href="https://github.com/scipy/scipy/pull/4780">https://github.com/scipy/scipy/pull/4780</a>>`__: Include apparently-forgotten functions in docs<br>- - `#4783 <<a href="https://github.com/scipy/scipy/pull/4783">https://github.com/scipy/scipy/pull/4783</a>>`__: Added many missing special functions to docs<br>- - `#4784 <<a href="https://github.com/scipy/scipy/pull/4784">https://github.com/scipy/scipy/pull/4784</a>>`__: add an axis attribute to PPoly and friends<br>- - `#4785 <<a href="https://github.com/scipy/scipy/pull/4785">https://github.com/scipy/scipy/pull/4785</a>>`__: Brief note about origin of Lena image<br>- - `#4786 <<a href="https://github.com/scipy/scipy/pull/4786">https://github.com/scipy/scipy/pull/4786</a>>`__: DOC: reformat the Methods section of the KDE docstring<br>- - `#4787 <<a href="https://github.com/scipy/scipy/pull/4787">https://github.com/scipy/scipy/pull/4787</a>>`__: Add rice cdf and ppf.<br>- - `#4792 <<a href="https://github.com/scipy/scipy/pull/4792">https://github.com/scipy/scipy/pull/4792</a>>`__: CI: add a kludge for detecting test failures which try to disguise...<br>- - `#4795 <<a href="https://github.com/scipy/scipy/pull/4795">https://github.com/scipy/scipy/pull/4795</a>>`__: Make refguide_check smarter about false positives<br>- - `#4797 <<a href="https://github.com/scipy/scipy/pull/4797">https://github.com/scipy/scipy/pull/4797</a>>`__: BUG/TST: numpoints not updated for incremental Voronoi<br>- - `#4799 <<a href="https://github.com/scipy/scipy/pull/4799">https://github.com/scipy/scipy/pull/4799</a>>`__: BUG: spatial: Fix a couple edge cases for the Mahalanobis metric...<br>- - `#4801 <<a href="https://github.com/scipy/scipy/pull/4801">https://github.com/scipy/scipy/pull/4801</a>>`__: BUG: Fix TypeError in scipy.optimize._trust-region.py when disp=True.<br>- - `#4803 <<a href="https://github.com/scipy/scipy/pull/4803">https://github.com/scipy/scipy/pull/4803</a>>`__: Issues with relaxed strides in QR updating routines<br>- - `#4806 <<a href="https://github.com/scipy/scipy/pull/4806">https://github.com/scipy/scipy/pull/4806</a>>`__: MAINT: use an informed initial guess for cauchy fit<br>- - `#4810 <<a href="https://github.com/scipy/scipy/pull/4810">https://github.com/scipy/scipy/pull/4810</a>>`__: PEP8ify codata.py<br>- - `#4812 <<a href="https://github.com/scipy/scipy/pull/4812">https://github.com/scipy/scipy/pull/4812</a>>`__: BUG: Relaxed strides cleanup in <a href="http://decomp_update.pyx.in">decomp_update.pyx.in</a><br>- - `#4820 <<a href="https://github.com/scipy/scipy/pull/4820">https://github.com/scipy/scipy/pull/4820</a>>`__: BLD: update Bento build for sgemv fix and install cython blas/lapack...<br>- - `#4823 <<a href="https://github.com/scipy/scipy/pull/4823">https://github.com/scipy/scipy/pull/4823</a>>`__: ENH: scipy.signal - Addition of spectrogram function<br>- - `#4827 <<a href="https://github.com/scipy/scipy/pull/4827">https://github.com/scipy/scipy/pull/4827</a>>`__: DOC: add csd and coherence to __init__.py<br>- - `#4833 <<a href="https://github.com/scipy/scipy/pull/4833">https://github.com/scipy/scipy/pull/4833</a>>`__: BLD: fix issue in linalg ``*lange`` wrappers for g77 builds.<br>- - `#4841 <<a href="https://github.com/scipy/scipy/pull/4841">https://github.com/scipy/scipy/pull/4841</a>>`__: TST: fix test failures in scipy.special with mingw32 due to test...<br>- - `#4842 <<a href="https://github.com/scipy/scipy/pull/4842">https://github.com/scipy/scipy/pull/4842</a>>`__: DOC: update site.cfg.example. Mostly taken over from Numpy<br>- - `#4845 <<a href="https://github.com/scipy/scipy/pull/4845">https://github.com/scipy/scipy/pull/4845</a>>`__: BUG: signal: Make spectrogram's return values order match the...<br>- - `#4849 <<a href="https://github.com/scipy/scipy/pull/4849">https://github.com/scipy/scipy/pull/4849</a>>`__: DOC:Fix error in ode docstring example<br>- - `#4856 <<a href="https://github.com/scipy/scipy/pull/4856">https://github.com/scipy/scipy/pull/4856</a>>`__: BUG: fix typo causing memleak<br><br>Checksums<br>=========<br><br>MD5<br>~~~<br><br>1c6faa58d12c7b642e64a44b57c311c3  scipy-0.16.0-win32-superpack-python2.7.exe<br>18b9b53af7216ab897495cc77068285b  scipy-0.16.0-win32-superpack-python3.3.exe<br>9cef8bc882e21854791ec80140258bc9  scipy-0.16.0-win32-superpack-python3.4.exe<br>eb95dda0f36cc3096673993a350cde77  scipy-0.16.0.tar.gz<br>fe1425745ab68d9d4ccaf59e854f1c28  scipy-0.16.0.tar.xz<br>1764bd452a72698b968ad13e51e28053  scipy-0.16.0.zip<br><br>SHA256<br>~~~~~~<br><br>b752366fafa3fddb96352d7b3259f7b3e58fae9f45d5a98eb91bd80005d75dfc  scipy-0.16.0-win32-superpack-python2.7.exe<br>369777d27da760d498a9312696235ab9e90359d9f4e02347669cbf56a42312a8  scipy-0.16.0-win32-superpack-python3.3.exe<br>bcd480ce8e8289942e57e7868d07e9a35982bc30a79150006ad085ce4c06803e  scipy-0.16.0-win32-superpack-python3.4.exe<br>92592f40097098f3fdbe7f5855d535b29bb16719c2bb59c728bce5e7a28790e0  scipy-0.16.0.tar.gz<br>e27f5cfa985cb1253e15aaeddc3dcd512d6853b05e84454f7f43b53b35514071  scipy-0.16.0.tar.xz<br>c9758971df994d238a4d0ff1d47ba5b02f1cb402d6e1925c921a452bc430a3d5  scipy-0.16.0.zip<br>-----BEGIN PGP SIGNATURE-----<br>Version: GnuPG v1<br><br>iQEcBAEBAgAGBQJVspIaAAoJEO2+o3i/Gl69n3cIAJdoEGIq/8MTsywYL6k5zsqA<br>aBK1Q9aB4qJcCLwM6ULKErxhY9lROzgljSvl22dCaD7YYYgD4Q03+BaXjIrHenbc<br>+sX5CzBPoz+BFjh7tTnfU5a6pVhqjQbW17A0TF0j6jah29pFnM2Xdf3zgHc+3f/B<br>U6JC698wDKROGlvKqWcwKcs2+EPBuu92gNa/rRCmMdnt9dIqVM8+otRNMgPVCZ+R<br>SgfneSGjZ4vXuBK3zWgcP0+r8Ek0DkUuFhEAK3W8NhEFCqd1kHkdvN+RIl6pGfHZ<br>OAHbzds6+VHgvQ3a4g2efJY3CD0LvtOgeS3R3NdmT3gCxkJtZpHAsczFhwKIWHM=<br>=QZFz<br>-----END PGP SIGNATURE-----<br></div></div>