From ralf.gommers at gmail.com Thu Mar 2 05:28:22 2017 From: ralf.gommers at gmail.com (Ralf Gommers) Date: Thu, 2 Mar 2017 23:28:22 +1300 Subject: [SciPy-User] [numfocus] Docathon : focus on documentation on your favorite opensource project! In-Reply-To: References: Message-ID: This is awesome, so I've taken the liberty of signing SciPy up. Reminds me of the NumPy & SciPy Documentation Marathon - that's how I got started contributing 9 years ago. Next week is pretty poor timing for me, but I'm going to get at least 1 PR in and review as many as I can. There's no specific site or issues marked for this docathon, but it's easy to participate. It's just a matter of finding functions with incomplete documentation (that's not hard ....) - adding a usage example can be a major improvement already. Cheers, Ralf On Thu, Mar 2, 2017 at 2:02 PM, Nelle Varoquaux wrote: > Hi everyone, > > Apologies for cross-posting : this event might be of interest to some of > the projects of the scientific Python community. We are trying to encourage > FOSS developers to focus on documentation for a week instead of fixing bugs > or implementing cool features! > > Here are more informations about the project. > > Thanks, > Nelle > Sign up your project for the docathon! > > The Docathon is happening next week! We?ve already got several projects > signed up to participate in improving their documentation during the week. > We?ve put together a nifty project board > so that we > can keep track of everybody?s progress during the week! If you sign up as > a project , we?ll post your > documentation commit stats like this: > > How can I join in? > We want you to improve your documentation, wherever you are. To that > extent, we?ll keep track of project activity regardless of its location. If > you?d like to work with a group of people, here are a few specifics: > > To kick off the docathon we?ll have a morning of tutorials on Monday, > March 6th. These will cover particular tools and techniques for building > great documentation. If you?re at Berkeley then you can sign up here > . > This will also be live-streamed on Youtube, so you can watch from wherever > you are! > > We?ll also have some working groups meeting periodically in cities around > the country. If you?d like to join in with these groups, click one of these > links: > > > - > > New York City - Signup > / Agenda > > - > > Berkeley - Signup > > / Agenda > - > > Seattle - Signup / Agenda > > > > You can also work remotely if you like, we will coordinate people via > email/GitHub, too. > > Wherever you are, don?t forget to sign up as a participant > so we can give some pointers on > how to contribute. Or, suggest a project > to work on and we?ll keep track > of its activity on our projects page > . > > Contact > If you have any questions, check out the Docathon website > or open an issue on our GitHub repo > . > > Please feel free to forward this email to anyone who may be interested. > We'd love for other institutions/groups to get involved. > > -- > You received this message because you are subscribed to the Google Groups > "NumFOCUS" group. > To unsubscribe from this group and stop receiving emails from it, send an > email to numfocus+unsubscribe at googlegroups.com. > For more options, visit https://groups.google.com/d/optout. > -------------- next part -------------- An HTML attachment was scrubbed... URL: From charlesr.harris at gmail.com Mon Mar 6 22:57:25 2017 From: charlesr.harris at gmail.com (Charles R Harris) Date: Mon, 6 Mar 2017 20:57:25 -0700 Subject: [SciPy-User] NumPy pre-release 1.12.1rc1 Message-ID: Hi All, I'm pleased to announce the release of NumPy 1.12.1rc1. NumPy 1.12.1rc1 supports Python 2.7 and 3.4 - 3.6 and fixes bugs and regressions found in NumPy 1.12.0. In particular, the regression in f2py constant parsing is fixed. Wheels for Linux, Windows, and OSX can be found on pypi. Archives can be downloaded from github . *Contributors* A total of 10 people contributed to this release. People with a "+" by their names contributed a patch for the first time. * Charles Harris * Eric Wieser * Greg Young * Joerg Behrmann + * John Kirkham * Julian Taylor * Marten van Kerkwijk * Matthew Brett * Shota Kawabuchi * Jean Utke + *Fixes Backported* * #8483: BUG: Fix wrong future nat warning and equiv type logic error... * #8489: BUG: Fix wrong masked median for some special cases * #8490: DOC: Place np.average in inline code * #8491: TST: Work around isfinite inconsistency on i386 * #8494: BUG: Guard against replacing constants without `'_'` spec in f2py. * #8524: BUG: Fix mean for float 16 non-array inputs for 1.12 * #8571: BUG: Fix calling python api with error set and minor leaks for... * #8602: BUG: Make iscomplexobj compatible with custom dtypes again * #8618: BUG: Fix undefined behaviour induced by bad `__array_wrap__` * #8648: BUG: Fix `MaskedArray.__setitem__` * #8659: BUG: PPC64el machines are POWER for Fortran in f2py * #8665: BUG: Look up methods on MaskedArray in `_frommethod` * #8674: BUG: Remove extra digit in `binary_repr` at limit * #8704: BUG: Fix deepcopy regression for empty arrays. * #8707: BUG: Fix ma.median for empty ndarrays Cheers, Chuck -------------- next part -------------- An HTML attachment was scrubbed... URL: From andyfaff at gmail.com Tue Mar 7 20:38:00 2017 From: andyfaff at gmail.com (Andrew Nelson) Date: Wed, 8 Mar 2017 12:38:00 +1100 Subject: [SciPy-User] [numfocus] Docathon : focus on documentation on your favorite opensource project! In-Reply-To: References: Message-ID: On 2 March 2017 at 21:28, Ralf Gommers wrote: > This is awesome, so I've taken the liberty of signing SciPy up. Reminds me > of the NumPy & SciPy Documentation Marathon - that's how I got started > contributing 9 years ago. > Discrepancies in scipy.optimize.minimize(method='L-BFGS-B'), https://github.com/scipy/scipy/issues/5231, is a very worth candidate for this marathon. Is there anyone up for doing this? -------------- next part -------------- An HTML attachment was scrubbed... URL: From evgeny.burovskiy at gmail.com Thu Mar 9 10:54:31 2017 From: evgeny.burovskiy at gmail.com (Evgeni Burovski) Date: Thu, 9 Mar 2017 18:54:31 +0300 Subject: [SciPy-User] ANN: SciPy 0.19.0 Message-ID: On behalf of the Scipy development team I am pleased to announce the availability of Scipy 0.19.0. This release contains several great new features and a large number of bug fixes and various improvements, as detailed in the release notes below. 121 people contributed to this release over the course of seven months. Thanks to everyone who contributed! This release requires Python 2.7 or 3.4-3.6 and NumPy 1.8.2 or greater. Source tarballs and release notes can be found at https://github.com/scipy/scipy/releases/tag/v0.19.0. OS X and Linux wheels are available from PyPI. For security-conscious, the wheels themselves are signed with my GPG key. Additionally, you can checksum the wheels and verify the checksums with those listed below or in the README file at https://github.com/scipy/scipy/releases/tag/v0.19.0. Cheers, Evgeni -----BEGIN PGP SIGNED MESSAGE----- Hash: SHA256 ========================== SciPy 0.19.0 Release Notes ========================== .. contents:: SciPy 0.19.0 is the culmination of 7 months of hard work. It contains many new features, numerous bug-fixes, improved test coverage and better documentation. There have been a number of deprecations and API changes in this release, which are documented below. All users are encouraged to upgrade to this release, as there are a large number of bug-fixes and optimizations. Moreover, our development attention will now shift to bug-fix releases on the 0.19.x branch, and on adding new features on the master branch. This release requires Python 2.7 or 3.4-3.6 and NumPy 1.8.2 or greater. Highlights of this release include: - - A unified foreign function interface layer, `scipy.LowLevelCallable`. - - Cython API for scalar, typed versions of the universal functions from the `scipy.special` module, via `cimport scipy.special.cython_special`. New features ============ Foreign function interface improvements - --------------------------------------- `scipy.LowLevelCallable` provides a new unified interface for wrapping low-level compiled callback functions in the Python space. It supports Cython imported "api" functions, ctypes function pointers, CFFI function pointers, ``PyCapsules``, Numba jitted functions and more. See `gh-6509 `_ for details. `scipy.linalg` improvements - --------------------------- The function `scipy.linalg.solve` obtained two more keywords ``assume_a`` and ``transposed``. The underlying LAPACK routines are replaced with "expert" versions and now can also be used to solve symmetric, hermitian and positive definite coefficient matrices. Moreover, ill-conditioned matrices now cause a warning to be emitted with the estimated condition number information. Old ``sym_pos`` keyword is kept for backwards compatibility reasons however it is identical to using ``assume_a='pos'``. Moreover, the ``debug`` keyword, which had no function but only printing the ``overwrite_`` values, is deprecated. The function `scipy.linalg.matrix_balance` was added to perform the so-called matrix balancing using the LAPACK xGEBAL routine family. This can be used to approximately equate the row and column norms through diagonal similarity transformations. The functions `scipy.linalg.solve_continuous_are` and `scipy.linalg.solve_discrete_are` have numerically more stable algorithms. These functions can also solve generalized algebraic matrix Riccati equations. Moreover, both gained a ``balanced`` keyword to turn balancing on and off. `scipy.spatial` improvements - ---------------------------- `scipy.spatial.SphericalVoronoi.sort_vertices_of_regions` has been re-written in Cython to improve performance. `scipy.spatial.SphericalVoronoi` can handle > 200 k points (at least 10 million) and has improved performance. The function `scipy.spatial.distance.directed_hausdorff` was added to calculate the directed Hausdorff distance. ``count_neighbors`` method of `scipy.spatial.cKDTree` gained an ability to perform weighted pair counting via the new keywords ``weights`` and ``cumulative``. See `gh-5647 `_ for details. `scipy.spatial.distance.pdist` and `scipy.spatial.distance.cdist` now support non-double custom metrics. `scipy.ndimage` improvements - ---------------------------- The callback function C API supports PyCapsules in Python 2.7 Multidimensional filters now allow having different extrapolation modes for different axes. `scipy.optimize` improvements - ----------------------------- The `scipy.optimize.basinhopping` global minimizer obtained a new keyword, `seed`, which can be used to seed the random number generator and obtain repeatable minimizations. The keyword `sigma` in `scipy.optimize.curve_fit` was overloaded to also accept the covariance matrix of errors in the data. `scipy.signal` improvements - --------------------------- The function `scipy.signal.correlate` and `scipy.signal.convolve` have a new optional parameter `method`. The default value of `auto` estimates the fastest of two computation methods, the direct approach and the Fourier transform approach. A new function has been added to choose the convolution/correlation method, `scipy.signal.choose_conv_method` which may be appropriate if convolutions or correlations are performed on many arrays of the same size. New functions have been added to calculate complex short time fourier transforms of an input signal, and to invert the transform to recover the original signal: `scipy.signal.stft` and `scipy.signal.istft`. This implementation also fixes the previously incorrect ouput of `scipy.signal.spectrogram` when complex output data were requested. The function `scipy.signal.sosfreqz` was added to compute the frequency response from second-order sections. The function `scipy.signal.unit_impulse` was added to conveniently generate an impulse function. The function `scipy.signal.iirnotch` was added to design second-order IIR notch filters that can be used to remove a frequency component from a signal. The dual function `scipy.signal.iirpeak` was added to compute the coefficients of a second-order IIR peak (resonant) filter. The function `scipy.signal.minimum_phase` was added to convert linear-phase FIR filters to minimum phase. The functions `scipy.signal.upfirdn` and `scipy.signal.resample_poly` are now substantially faster when operating on some n-dimensional arrays when n > 1. The largest reduction in computation time is realized in cases where the size of the array is small (<1k samples or so) along the axis to be filtered. `scipy.fftpack` improvements - ---------------------------- Fast Fourier transform routines now accept `np.float16` inputs and upcast them to `np.float32`. Previously, they would raise an error. `scipy.cluster` improvements - ---------------------------- Methods ``"centroid"`` and ``"median"`` of `scipy.cluster.hierarchy.linkage` have been significantly sped up. Long-standing issues with using ``linkage`` on large input data (over 16 GB) have been resolved. `scipy.sparse` improvements - --------------------------- The functions `scipy.sparse.save_npz` and `scipy.sparse.load_npz` were added, providing simple serialization for some sparse formats. The `prune` method of classes `bsr_matrix`, `csc_matrix`, and `csr_matrix` was updated to reallocate backing arrays under certain conditions, reducing memory usage. The methods `argmin` and `argmax` were added to classes `coo_matrix`, `csc_matrix`, `csr_matrix`, and `bsr_matrix`. New function `scipy.sparse.csgraph.structural_rank` computes the structural rank of a graph with a given sparsity pattern. New function `scipy.sparse.linalg.spsolve_triangular` solves a sparse linear system with a triangular left hand side matrix. `scipy.special` improvements - ---------------------------- Scalar, typed versions of universal functions from `scipy.special` are available in the Cython space via ``cimport`` from the new module `scipy.special.cython_special`. These scalar functions can be expected to be significantly faster then the universal functions for scalar arguments. See the `scipy.special` tutorial for details. Better control over special-function errors is offered by the functions `scipy.special.geterr` and `scipy.special.seterr` and the context manager `scipy.special.errstate`. The names of orthogonal polynomial root functions have been changed to be consistent with other functions relating to orthogonal polynomials. For example, `scipy.special.j_roots` has been renamed `scipy.special.roots_jacobi` for consistency with the related functions `scipy.special.jacobi` and `scipy.special.eval_jacobi`. To preserve back-compatibility the old names have been left as aliases. Wright Omega function is implemented as `scipy.special.wrightomega`. `scipy.stats` improvements - -------------------------- The function `scipy.stats.weightedtau` was added. It provides a weighted version of Kendall's tau. New class `scipy.stats.multinomial` implements the multinomial distribution. New class `scipy.stats.rv_histogram` constructs a continuous univariate distribution with a piecewise linear CDF from a binned data sample. New class `scipy.stats.argus` implements the Argus distribution. `scipy.interpolate` improvements - -------------------------------- New class `scipy.interpolate.BSpline` represents splines. ``BSpline`` objects contain knots and coefficients and can evaluate the spline. The format is consistent with FITPACK, so that one can do, for example:: >>> t, c, k = splrep(x, y, s=0) >>> spl = BSpline(t, c, k) >>> np.allclose(spl(x), y) ``spl*`` functions, `scipy.interpolate.splev`, `scipy.interpolate.splint`, `scipy.interpolate.splder` and `scipy.interpolate.splantider`, accept both ``BSpline`` objects and ``(t, c, k)`` tuples for backwards compatibility. For multidimensional splines, ``c.ndim > 1``, ``BSpline`` objects are consistent with piecewise polynomials, `scipy.interpolate.PPoly`. This means that ``BSpline`` objects are not immediately consistent with `scipy.interpolate.splprep`, and one *cannot* do ``>>> BSpline(*splprep([x, y])[0])``. Consult the `scipy.interpolate` test suite for examples of the precise equivalence. In new code, prefer using ``scipy.interpolate.BSpline`` objects instead of manipulating ``(t, c, k)`` tuples directly. New function `scipy.interpolate.make_interp_spline` constructs an interpolating spline given data points and boundary conditions. New function `scipy.interpolate.make_lsq_spline` constructs a least-squares spline approximation given data points. `scipy.integrate` improvements - ------------------------------ Now `scipy.integrate.fixed_quad` supports vector-valued functions. Deprecated features =================== `scipy.interpolate.splmake`, `scipy.interpolate.spleval` and `scipy.interpolate.spline` are deprecated. The format used by `splmake/spleval` was inconsistent with `splrep/splev` which was confusing to users. `scipy.special.errprint` is deprecated. Improved functionality is available in `scipy.special.seterr`. calling `scipy.spatial.distance.pdist` or `scipy.spatial.distance.cdist` with arguments not needed by the chosen metric is deprecated. Also, metrics `"old_cosine"` and `"old_cos"` are deprecated. Backwards incompatible changes ============================== The deprecated ``scipy.weave`` submodule was removed. `scipy.spatial.distance.squareform` now returns arrays of the same dtype as the input, instead of always float64. `scipy.special.errprint` now returns a boolean. The function `scipy.signal.find_peaks_cwt` now returns an array instead of a list. `scipy.stats.kendalltau` now computes the correct p-value in case the input contains ties. The p-value is also identical to that computed by `scipy.stats.mstats.kendalltau` and by R. If the input does not contain ties there is no change w.r.t. the previous implementation. The function `scipy.linalg.block_diag` will not ignore zero-sized matrices anymore. Instead it will insert rows or columns of zeros of the appropriate size. See gh-4908 for more details. Other changes ============= SciPy wheels will now report their dependency on ``numpy`` on all platforms. This change was made because Numpy wheels are available, and because the pip upgrade behavior is finally changing for the better (use ``--upgrade-strategy=only-if-needed`` for ``pip >= 8.2``; that behavior will become the default in the next major version of ``pip``). Numerical values returned by `scipy.interpolate.interp1d` with ``kind="cubic"`` and ``"quadratic"`` may change relative to previous scipy versions. If your code depended on specific numeric values (i.e., on implementation details of the interpolators), you may want to double-check your results. Authors ======= * @endolith * Max Argus + * Herv? Audren * Alessandro Pietro Bardelli + * Michael Benfield + * Felix Berkenkamp * Matthew Brett * Per Brodtkorb * Evgeni Burovski * Pierre de Buyl * CJ Carey * Brandon Carter + * Tim Cera * Klesk Chonkin * Christian H?ggstr?m + * Luca Citi * Peadar Coyle + * Daniel da Silva + * Greg Dooper + * John Draper + * drlvk + * David Ellis + * Yu Feng * Baptiste Fontaine + * Jed Frey + * Siddhartha Gandhi + * Wim Glenn + * Akash Goel + * Christoph Gohlke * Ralf Gommers * Alexander Goncearenco + * Richard Gowers + * Alex Griffing * Radoslaw Guzinski + * Charles Harris * Callum Jacob Hays + * Ian Henriksen * Randy Heydon + * Lindsey Hiltner + * Gerrit Holl + * Hiroki IKEDA + * jfinkels + * Mher Kazandjian + * Thomas Keck + * keuj6 + * Kornel Kielczewski + * Sergey B Kirpichev + * Vasily Kokorev + * Eric Larson * Denis Laxalde * Gregory R. Lee * Josh Lefler + * Julien Lhermitte + * Evan Limanto + * Jin-Guo Liu + * Nikolay Mayorov * Geordie McBain + * Josue Melka + * Matthieu Melot * michaelvmartin15 + * Surhud More + * Brett M. Morris + * Chris Mutel + * Paul Nation * Andrew Nelson * David Nicholson + * Aaron Nielsen + * Joel Nothman * nrnrk + * Juan Nunez-Iglesias * Mikhail Pak + * Gavin Parnaby + * Thomas Pingel + * Ilhan Polat + * Aman Pratik + * Sebastian Pucilowski * Ted Pudlik * puenka + * Eric Quintero * Tyler Reddy * Joscha Reimer * Antonio Horta Ribeiro + * Edward Richards + * Roman Ring + * Rafael Rossi + * Colm Ryan + * Sami Salonen + * Alvaro Sanchez-Gonzalez + * Johannes Schmitz * Kari Schoonbee * Yurii Shevchuk + * Jonathan Siebert + * Jonathan Tammo Siebert + * Scott Sievert + * Sourav Singh * Byron Smith + * Srikiran + * Samuel St-Jean + * Yoni Teitelbaum + * Bhavika Tekwani * Martin Thoma * timbalam + * Svend Vanderveken + * Sebastiano Vigna + * Aditya Vijaykumar + * Santi Villalba + * Ze Vinicius * Pauli Virtanen * Matteo Visconti * Yusuke Watanabe + * Warren Weckesser * Phillip Weinberg + * Nils Werner * Jakub Wilk * Josh Wilson * wirew0rm + * David Wolever + * Nathan Woods * ybeltukov + * G Young * Evgeny Zhurko + A total of 121 people contributed to this release. People with a "+" by their names contributed a patch for the first time. This list of names is automatically generated, and may not be fully complete. Issues closed for 0.19.0 - ------------------------ - - `#1767 `__: Function definitions in __fitpack.h should be moved. (Trac #1240) - - `#1774 `__: _kmeans chokes on large thresholds (Trac #1247) - - `#2089 `__: Integer overflows cause segfault in linkage function with large... - - `#2190 `__: Are odd-length window functions supposed to be always symmetrical?... - - `#2251 `__: solve_discrete_are in scipy.linalg does (sometimes) not solve... - - `#2580 `__: scipy.interpolate.UnivariateSpline (or a new superclass of it)... - - `#2592 `__: scipy.stats.anderson assumes gumbel_l - - `#3054 `__: scipy.linalg.eig does not handle infinite eigenvalues - - `#3160 `__: multinomial pmf / logpmf - - `#3904 `__: scipy.special.ellipj dn wrong values at quarter period - - `#4044 `__: Inconsistent code book initialization in kmeans - - `#4234 `__: scipy.signal.flattop documentation doesn't list a source for... - - `#4831 `__: Bugs in C code in __quadpack.h - - `#4908 `__: bug: unnessesary validity check for block dimension in scipy.sparse.block_diag - - `#4917 `__: BUG: indexing error for sparse matrix with ix_ - - `#4938 `__: Docs on extending ndimage need to be updated. - - `#5056 `__: sparse matrix element-wise multiplying dense matrix returns dense... - - `#5337 `__: Formula in documentation for correlate is wrong - - `#5537 `__: use OrderedDict in io.netcdf - - `#5750 `__: [doc] missing data index value in KDTree, cKDTree - - `#5755 `__: p-value computation in scipy.stats.kendalltau() in broken in... - - `#5757 `__: BUG: Incorrect complex output of signal.spectrogram - - `#5964 `__: ENH: expose scalar versions of scipy.special functions to cython - - `#6107 `__: scipy.cluster.hierarchy.single segmentation fault with 2**16... - - `#6278 `__: optimize.basinhopping should take a RandomState object - - `#6296 `__: InterpolatedUnivariateSpline: check_finite fails when w is unspecified - - `#6306 `__: Anderson-Darling bad results - - `#6314 `__: scipy.stats.kendaltau() p value not in agreement with R, SPSS... - - `#6340 `__: Curve_fit bounds and maxfev - - `#6377 `__: expm_multiply, complex matrices not working using start,stop,ect... - - `#6382 `__: optimize.differential_evolution stopping criterion has unintuitive... - - `#6391 `__: Global Benchmarking times out at 600s. - - `#6397 `__: mmwrite errors with large (but still 64-bit) integers - - `#6413 `__: scipy.stats.dirichlet computes multivariate gaussian differential... - - `#6428 `__: scipy.stats.mstats.mode modifies input - - `#6440 `__: Figure out ABI break policy for scipy.special Cython API - - `#6441 `__: Using Qhull for halfspace intersection : segfault - - `#6442 `__: scipy.spatial : In incremental mode volume is not recomputed - - `#6451 `__: Documentation for scipy.cluster.hierarchy.to_tree is confusing... - - `#6490 `__: interp1d (kind=zero) returns wrong value for rightmost interpolation... - - `#6521 `__: scipy.stats.entropy does *not* calculate the KL divergence - - `#6530 `__: scipy.stats.spearmanr unexpected NaN handling - - `#6541 `__: Test runner does not run scipy._lib/tests? - - `#6552 `__: BUG: misc.bytescale returns unexpected results when using cmin/cmax... - - `#6556 `__: RectSphereBivariateSpline(u, v, r) fails if min(v) >= pi - - `#6559 `__: Differential_evolution maxiter causing memory overflow - - `#6565 `__: Coverage of spectral functions could be improved - - `#6628 `__: Incorrect parameter name in binomial documentation - - `#6634 `__: Expose LAPACK's xGESVX family for linalg.solve ill-conditioned... - - `#6657 `__: Confusing documentation for `scipy.special.sph_harm` - - `#6676 `__: optimize: Incorrect size of Jacobian returned by `minimize(...,... - - `#6681 `__: add a new context manager to wrap `scipy.special.seterr` - - `#6700 `__: BUG: scipy.io.wavfile.read stays in infinite loop, warns on wav... - - `#6721 `__: scipy.special.chebyt(N) throw a 'TypeError' when N > 64 - - `#6727 `__: Documentation for scipy.stats.norm.fit is incorrect - - `#6764 `__: Documentation for scipy.spatial.Delaunay is partially incorrect - - `#6811 `__: scipy.spatial.SphericalVoronoi fails for large number of points - - `#6841 `__: spearmanr fails when nan_policy='omit' is set - - `#6869 `__: Currently in gaussian_kde, the logpdf function is calculated... - - `#6875 `__: SLSQP inconsistent handling of invalid bounds - - `#6876 `__: Python stopped working (Segfault?) with minimum/maximum filter... - - `#6889 `__: dblquad gives different results under scipy 0.17.1 and 0.18.1 - - `#6898 `__: BUG: dblquad ignores error tolerances - - `#6901 `__: Solving sparse linear systems in CSR format with complex values - - `#6903 `__: issue in spatial.distance.pdist docstring - - `#6917 `__: Problem in passing drop_rule to scipy.sparse.linalg.spilu - - `#6926 `__: signature mismatches for LowLevelCallable - - `#6961 `__: Scipy contains shebang pointing to /usr/bin/python and /bin/bash... - - `#6972 `__: BUG: special: `generate_ufuncs.py` is broken - - `#6984 `__: Assert raises test failure for test_ill_condition_warning - - `#6990 `__: BUG: sparse: Bad documentation of the `k` argument in `sparse.linalg.eigs` - - `#6991 `__: Division by zero in linregress() - - `#7011 `__: possible speed improvment in rv_continuous.fit() - - `#7015 `__: Test failure with Python 3.5 and numpy master - - `#7055 `__: SciPy 0.19.0rc1 test errors and failures on Windows - - `#7096 `__: macOS test failues for test_solve_continuous_are - - `#7100 `__: test_distance.test_Xdist_deprecated_args test error in 0.19.0rc2 Pull requests for 0.19.0 - ------------------------ - - `#2908 `__: Scipy 1.0 Roadmap - - `#3174 `__: add b-splines - - `#4606 `__: ENH: Add a unit impulse waveform function - - `#5608 `__: Adds keyword argument to choose faster convolution method - - `#5647 `__: ENH: Faster count_neighour in cKDTree / + weighted input data - - `#6021 `__: Netcdf append - - `#6058 `__: ENH: scipy.signal - Add stft and istft - - `#6059 `__: ENH: More accurate signal.freqresp for zpk systems - - `#6195 `__: ENH: Cython interface for special - - `#6234 `__: DOC: Fixed a typo in ward() help - - `#6261 `__: ENH: add docstring and clean up code for signal.normalize - - `#6270 `__: MAINT: special: add tests for cdflib - - `#6271 `__: Fix for scipy.cluster.hierarchy.is_isomorphic - - `#6273 `__: optimize: rewrite while loops as for loops - - `#6279 `__: MAINT: Bessel tweaks - - `#6291 `__: Fixes gh-6219: remove runtime warning from genextreme distribution - - `#6294 `__: STY: Some PEP8 and cleaning up imports in stats/_continuous_distns.py - - `#6297 `__: Clarify docs in misc/__init__.py - - `#6300 `__: ENH: sparse: Loosen input validation for `diags` with empty inputs - - `#6301 `__: BUG: standardizes check_finite behavior re optional weights,... - - `#6303 `__: Fixing example in _lazyselect docstring. - - `#6307 `__: MAINT: more improvements to gammainc/gammaincc - - `#6308 `__: Clarified documentation of hypergeometric distribution. - - `#6309 `__: BUG: stats: Improve calculation of the Anderson-Darling statistic. - - `#6315 `__: ENH: Descending order of x in PPoly - - `#6317 `__: ENH: stats: Add support for nan_policy to stats.median_test - - `#6321 `__: TST: fix a typo in test name - - `#6328 `__: ENH: sosfreqz - - `#6335 `__: Define LinregressResult outside of linregress - - `#6337 `__: In anderson test, added support for right skewed gumbel distribution. - - `#6341 `__: Accept several spellings for the curve_fit max number of function... - - `#6342 `__: DOC: cluster: clarify hierarchy.linkage usage - - `#6352 `__: DOC: removed brentq from its own 'see also' - - `#6362 `__: ENH: stats: Use explicit formulas for sf, logsf, etc in weibull... - - `#6369 `__: MAINT: special: add a comment to hyp0f1_complex - - `#6375 `__: Added the multinomial distribution. - - `#6387 `__: MAINT: special: improve accuracy of ellipj's `dn` at quarter... - - `#6388 `__: BenchmarkGlobal - getting it to work in Python3 - - `#6394 `__: ENH: scipy.sparse: add save and load functions for sparse matrices - - `#6400 `__: MAINT: moves global benchmark run from setup_cache to track_all - - `#6403 `__: ENH: seed kwd for basinhopping. Closes #6278 - - `#6404 `__: ENH: signal: added irrnotch and iirpeak functions. - - `#6406 `__: ENH: special: extend `sici`/`shichi` to complex arguments - - `#6407 `__: ENH: Window functions should not accept non-integer or negative... - - `#6408 `__: MAINT: _differentialevolution now uses _lib._util.check_random_state - - `#6427 `__: MAINT: Fix gmpy build & test that mpmath uses gmpy - - `#6439 `__: MAINT: ndimage: update callback function c api - - `#6443 `__: BUG: Fix volume computation in incremental mode - - `#6447 `__: Fixes issue #6413 - Minor documentation fix in the entropy function... - - `#6448 `__: ENH: Add halfspace mode to Qhull - - `#6449 `__: ENH: rtol and atol for differential_evolution termination fixes... - - `#6453 `__: DOC: Add some See Also links between similar functions - - `#6454 `__: DOC: linalg: clarify callable signature in `ordqz` - - `#6457 `__: ENH: spatial: enable non-double dtypes in squareform - - `#6459 `__: BUG: Complex matrices not handled correctly by expm_multiply... - - `#6465 `__: TST DOC Window docs, tests, etc. - - `#6469 `__: ENH: linalg: better handling of infinite eigenvalues in `eig`/`eigvals` - - `#6475 `__: DOC: calling interp1d/interp2d with NaNs is undefined - - `#6477 `__: Document magic numbers in optimize.py - - `#6481 `__: TST: Supress some warnings from test_windows - - `#6485 `__: DOC: spatial: correct typo in procrustes - - `#6487 `__: Fix Bray-Curtis formula in pdist docstring - - `#6493 `__: ENH: Add covariance functionality to scipy.optimize.curve_fit - - `#6494 `__: ENH: stats: Use log1p() to improve some calculations. - - `#6495 `__: BUG: Use MST algorithm instead of SLINK for single linkage clustering - - `#6497 `__: MRG: Add minimum_phase filter function - - `#6505 `__: reset scipy.signal.resample window shape to 1-D - - `#6507 `__: BUG: linkage: Raise exception if y contains non-finite elements - - `#6509 `__: ENH: _lib: add common machinery for low-level callback functions - - `#6520 `__: scipy.sparse.base.__mul__ non-numpy/scipy objects with 'shape'... - - `#6522 `__: Replace kl_div by rel_entr in entropy - - `#6524 `__: DOC: add next_fast_len to list of functions - - `#6527 `__: DOC: Release notes to reflect the new covariance feature in optimize.curve_fit - - `#6532 `__: ENH: Simplify _cos_win, document it, add symmetric/periodic arg - - `#6535 `__: MAINT: sparse.csgraph: updating old cython loops - - `#6540 `__: DOC: add to documentation of orthogonal polynomials - - `#6544 `__: TST: Ensure tests for scipy._lib are run by scipy.test() - - `#6546 `__: updated docstring of stats.linregress - - `#6553 `__: commited changes that I originally submitted for scipy.signal.cspline? - - `#6561 `__: BUG: modify signal.find_peaks_cwt() to return array and accept... - - `#6562 `__: DOC: Negative binomial distribution clarification - - `#6563 `__: MAINT: be more liberal in requiring numpy - - `#6567 `__: MAINT: use xrange for iteration in differential_evolution fixes... - - `#6572 `__: BUG: "sp.linalg.solve_discrete_are" fails for random data - - `#6578 `__: BUG: misc: allow both cmin/cmax and low/high params in bytescale - - `#6581 `__: Fix some unfortunate typos - - `#6582 `__: MAINT: linalg: make handling of infinite eigenvalues in `ordqz`... - - `#6585 `__: DOC: interpolate: correct seealso links to ndimage - - `#6588 `__: Update docstring of scipy.spatial.distance_matrix - - `#6592 `__: DOC: Replace 'first' by 'smallest' in mode - - `#6593 `__: MAINT: remove scipy.weave submodule - - `#6594 `__: DOC: distance.squareform: fix html docs, add note about dtype... - - `#6598 `__: [DOC] Fix incorrect error message in medfilt2d - - `#6599 `__: MAINT: linalg: turn a `solve_discrete_are` test back on - - `#6600 `__: DOC: Add SOS goals to roadmap - - `#6601 `__: DEP: Raise minimum numpy version to 1.8.2 - - `#6605 `__: MAINT: 'new' module is deprecated, don't use it - - `#6607 `__: DOC: add note on change in wheel dependency on numpy and pip... - - `#6609 `__: Fixes #6602 - Typo in docs - - `#6616 `__: ENH: generalization of continuous and discrete Riccati solvers... - - `#6621 `__: DOC: improve cluster.hierarchy docstrings. - - `#6623 `__: CS matrix prune method should copy data from large unpruned arrays - - `#6625 `__: DOC: special: complete documentation of `eval_*` functions - - `#6626 `__: TST: special: silence some deprecation warnings - - `#6631 `__: fix parameter name doc for discrete distributions - - `#6632 `__: MAINT: stats: change some instances of `special` to `sc` - - `#6633 `__: MAINT: refguide: py2k long integers are equal to py3k integers - - `#6638 `__: MAINT: change type declaration in cluster.linkage, prevent overflow - - `#6640 `__: BUG: fix issue with duplicate values used in cluster.vq.kmeans - - `#6641 `__: BUG: fix corner case in cluster.vq.kmeans for large thresholds - - `#6643 `__: MAINT: clean up truncation modes of dendrogram - - `#6645 `__: MAINT: special: rename `*_roots` functions - - `#6646 `__: MAINT: clean up mpmath imports - - `#6647 `__: DOC: add sqrt to Mahalanobis description for pdist - - `#6648 `__: DOC: special: add a section on `cython_special` to the tutorial - - `#6649 `__: ENH: Added scipy.spatial.distance.directed_hausdorff - - `#6650 `__: DOC: add Sphinx roles for DOI and arXiv links - - `#6651 `__: BUG: mstats: make sure mode(..., None) does not modify its input - - `#6652 `__: DOC: special: add section to tutorial on functions not in special - - `#6653 `__: ENH: special: add the Wright Omega function - - `#6656 `__: ENH: don't coerce input to double with custom metric in cdist... - - `#6658 `__: Faster/shorter code for computation of discordances - - `#6659 `__: DOC: special: make __init__ summaries and html summaries match - - `#6661 `__: general.rst: Fix a typo - - `#6664 `__: TST: Spectral functions' window correction factor - - `#6665 `__: [DOC] Conditions on v in RectSphereBivariateSpline - - `#6668 `__: DOC: Mention negative masses for center of mass - - `#6675 `__: MAINT: special: remove outdated README - - `#6677 `__: BUG: Fixes computation of p-values. - - `#6679 `__: BUG: optimize: return correct Jacobian for method 'SLSQP' in... - - `#6680 `__: ENH: Add structural rank to sparse.csgraph - - `#6686 `__: TST: Added Airspeed Velocity benchmarks for SphericalVoronoi - - `#6687 `__: DOC: add section "deciding on new features" to developer guide. - - `#6691 `__: ENH: Clearer error when fmin_slsqp obj doesn't return scalar - - `#6702 `__: TST: Added airspeed velocity benchmarks for scipy.spatial.distance.cdist - - `#6707 `__: TST: interpolate: test fitpack wrappers, not _impl - - `#6709 `__: TST: fix a number of test failures on 32-bit systems - - `#6711 `__: MAINT: move function definitions from __fitpack.h to _fitpackmodule.c - - `#6712 `__: MAINT: clean up wishlist in stats.morestats, and copyright statement. - - `#6715 `__: DOC: update the release notes with BSpline et al. - - `#6716 `__: MAINT: scipy.io.wavfile: No infinite loop when trying to read... - - `#6717 `__: some style cleanup - - `#6723 `__: BUG: special: cast to float before in-place multiplication in... - - `#6726 `__: address performance regressions in interp1d - - `#6728 `__: DOC: made code examples in `integrate` tutorial copy-pasteable - - `#6731 `__: DOC: scipy.optimize: Added an example for wrapping complex-valued... - - `#6732 `__: MAINT: cython_special: remove `errprint` - - `#6733 `__: MAINT: special: fix some pyflakes warnings - - `#6734 `__: DOC: sparse.linalg: fixed matrix description in `bicgstab` doc - - `#6737 `__: BLD: update `cythonize.py` to detect changes in pxi files - - `#6740 `__: DOC: special: some small fixes to docstrings - - `#6741 `__: MAINT: remove dead code in interpolate.py - - `#6742 `__: BUG: fix ``linalg.block_diag`` to support zero-sized matrices. - - `#6744 `__: ENH: interpolate: make PPoly.from_spline accept BSpline objects - - `#6746 `__: DOC: special: clarify use of Condon-Shortley phase in `sph_harm`/`lpmv` - - `#6750 `__: ENH: sparse: avoid densification on broadcasted elem-wise mult - - `#6751 `__: sinm doc explained cosm - - `#6753 `__: ENH: special: allow for more fine-tuned error handling - - `#6759 `__: Move logsumexp and pade from scipy.misc to scipy.special and... - - `#6761 `__: ENH: argmax and argmin methods for sparse matrices - - `#6762 `__: DOC: Improve docstrings of sparse matrices - - `#6763 `__: ENH: Weighted tau - - `#6768 `__: ENH: cythonized spherical Voronoi region polygon vertex sorting - - `#6770 `__: Correction of Delaunay class' documentation - - `#6775 `__: ENH: Integrating LAPACK "expert" routines with conditioning warnings... - - `#6776 `__: MAINT: Removing the trivial f2py warnings - - `#6777 `__: DOC: Update rv_continuous.fit doc. - - `#6778 `__: MAINT: cluster.hierarchy: Improved wording of error msgs - - `#6786 `__: BLD: increase minimum Cython version to 0.23.4 - - `#6787 `__: DOC: expand on ``linalg.block_diag`` changes in 0.19.0 release... - - `#6789 `__: ENH: Add further documentation for norm.fit - - `#6790 `__: MAINT: Fix a potential problem in nn_chain linkage algorithm - - `#6791 `__: DOC: Add examples to scipy.ndimage.fourier - - `#6792 `__: DOC: fix some numpydoc / Sphinx issues. - - `#6793 `__: MAINT: fix circular import after moving functions out of misc - - `#6796 `__: TST: test importing each submodule. Regression test for gh-6793. - - `#6799 `__: ENH: stats: Argus distribution - - `#6801 `__: ENH: stats: Histogram distribution - - `#6803 `__: TST: make sure tests for ``_build_utils`` are run. - - `#6804 `__: MAINT: more fixes in `loggamma` - - `#6806 `__: ENH: Faster linkage for 'centroid' and 'median' methods - - `#6810 `__: ENH: speed up upfirdn and resample_poly for n-dimensional arrays - - `#6812 `__: TST: Added ConvexHull asv benchmark code - - `#6814 `__: ENH: Different extrapolation modes for different dimensions in... - - `#6826 `__: Signal spectral window default fix - - `#6828 `__: BUG: SphericalVoronoi Space Complexity (Fixes #6811) - - `#6830 `__: RealData docstring correction - - `#6834 `__: DOC: Added reference for skewtest function. See #6829 - - `#6836 `__: DOC: Added mode='mirror' in the docstring for the functions accepting... - - `#6838 `__: MAINT: sparse: start removing old BSR methods - - `#6844 `__: handle incompatible dimensions when input is not an ndarray in... - - `#6847 `__: Added maxiter to golden search. - - `#6850 `__: BUG: added check for optional param scipy.stats.spearmanr - - `#6858 `__: MAINT: Removing redundant tests - - `#6861 `__: DEP: Fix escape sequences deprecated in Python 3.6. - - `#6862 `__: DOC: dx should be float, not int - - `#6863 `__: updated documentation curve_fit - - `#6866 `__: DOC : added some documentation to j1 referring to spherical_jn - - `#6867 `__: DOC: cdist move long examples list into Notes section - - `#6868 `__: BUG: Make stats.mode return a ModeResult namedtuple on empty... - - `#6871 `__: Corrected documentation. - - `#6874 `__: ENH: gaussian_kde.logpdf based on logsumexp - - `#6877 `__: BUG: ndimage: guard against footprints of all zeros - - `#6881 `__: python 3.6 - - `#6885 `__: Vectorized integrate.fixed_quad - - `#6886 `__: fixed typo - - `#6891 `__: TST: fix failures for linalg.dare/care due to tightened test... - - `#6892 `__: DOC: fix a bunch of Sphinx errors. - - `#6894 `__: TST: Added asv benchmarks for scipy.spatial.Voronoi - - `#6908 `__: BUG: Fix return dtype for complex input in spsolve - - `#6909 `__: ENH: fftpack: use float32 routines for float16 inputs. - - `#6911 `__: added min/max support to binned_statistic - - `#6913 `__: Fix 6875: SLSQP raise ValueError for all invalid bounds. - - `#6914 `__: DOCS: GH6903 updating docs of Spatial.distance.pdist - - `#6916 `__: MAINT: fix some issues for 32-bit Python - - `#6924 `__: BLD: update Bento build for scipy.LowLevelCallable - - `#6932 `__: ENH: Use OrderedDict in io.netcdf. Closes gh-5537 - - `#6933 `__: BUG: fix LowLevelCallable issue on 32-bit Python. - - `#6936 `__: BUG: sparse: handle size-1 2D indexes correctly - - `#6938 `__: TST: fix test failures in special on 32-bit Python. - - `#6939 `__: Added attributes list to cKDTree docstring - - `#6940 `__: improve efficiency of dok_matrix.tocoo - - `#6942 `__: DOC: add link to liac-arff package in the io.arff docstring. - - `#6943 `__: MAINT: Docstring fixes and an additional test for linalg.solve - - `#6944 `__: DOC: Add example of odeint with a banded Jacobian to the integrate... - - `#6946 `__: ENH: hypergeom.logpmf in terms of betaln - - `#6947 `__: TST: speedup distance tests - - `#6948 `__: DEP: Deprecate the keyword "debug" from linalg.solve - - `#6950 `__: BUG: Correctly treat large integers in MMIO (fixes #6397) - - `#6952 `__: ENH: Minor user-friendliness cleanup in LowLevelCallable - - `#6956 `__: DOC: improve description of 'output' keyword for convolve - - `#6957 `__: ENH more informative error in sparse.bmat - - `#6962 `__: Shebang fixes - - `#6964 `__: DOC: note argmin/argmax addition - - `#6965 `__: BUG: Fix issues passing error tolerances in dblquad and tplquad. - - `#6971 `__: fix the docstring of signaltools.correlate - - `#6973 `__: Silence expected numpy warnings in scipy.ndimage.interpolation.zoom() - - `#6975 `__: BUG: special: fix regex in `generate_ufuncs.py` - - `#6976 `__: Update docstring for griddata - - `#6978 `__: Avoid division by zero in zoom factor calculation - - `#6979 `__: BUG: ARE solvers did not check the generalized case carefully - - `#6985 `__: ENH: sparse: add scipy.sparse.linalg.spsolve_triangular - - `#6994 `__: MAINT: spatial: updates to plotting utils - - `#6995 `__: DOC: Bad documentation of k in sparse.linalg.eigs See #6990 - - `#6997 `__: TST: Changed the test with a less singular example - - `#7000 `__: DOC: clarify interp1d 'zero' argument - - `#7007 `__: BUG: Fix division by zero in linregress() for 2 data points - - `#7009 `__: BUG: Fix problem in passing drop_rule to scipy.sparse.linalg.spilu - - `#7012 `__: speed improvment in _distn_infrastructure.py - - `#7014 `__: Fix Typo: add a single quotation mark to fix a slight typo - - `#7021 `__: MAINT: stats: use machine constants from np.finfo, not machar - - `#7026 `__: MAINT: update .mailmap - - `#7032 `__: Fix layout of rv_histogram docs - - `#7035 `__: DOC: update 0.19.0 release notes - - `#7036 `__: ENH: Add more boundary options to signal.stft - - `#7040 `__: TST: stats: skip too slow tests - - `#7042 `__: MAINT: sparse: speed up setdiag tests - - `#7043 `__: MAINT: refactory and code cleaning Xdist - - `#7053 `__: Fix msvc 9 and 10 compile errors - - `#7060 `__: DOC: updated release notes with #7043 and #6656 - - `#7062 `__: MAINT: Change defaut STFT boundary kwarg to "zeros" - - `#7064 `__: Fix ValueError: path is on mount 'X:', start on mount 'D:' on... - - `#7067 `__: TST: Fix PermissionError: [Errno 13] Permission denied on Windows - - `#7068 `__: TST: Fix UnboundLocalError: local variable 'data' referenced... - - `#7069 `__: Fix OverflowError: Python int too large to convert to C long... - - `#7071 `__: TST: silence RuntimeWarning for nan test of stats.spearmanr - - `#7072 `__: Fix OverflowError: Python int too large to convert to C long... - - `#7084 `__: TST: linalg: bump tolerance in test_falker - - `#7095 `__: TST: linalg: bump more tolerances in test_falker - - `#7101 `__: TST: Relax solve_continuous_are test case 2 and 12 - - `#7106 `__: BUG: stop cdist "correlation" modifying input - - `#7116 `__: Backports to 0.19.0rc2 Checksums ========= MD5 ~~~ dde4d5d44a0274a5abb01be4a3cd486a scipy-0.19.0-cp27-cp27m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl 08809612b46e660e567e3272ec11c808 scipy-0.19.0-cp27-cp27m-manylinux1_i686.whl 0e49f7fc8d31c1c79f0a4d63b29e8a1f scipy-0.19.0-cp27-cp27m-manylinux1_x86_64.whl a2669158cf847856d292b8a60cdaa170 scipy-0.19.0-cp27-cp27mu-manylinux1_i686.whl adfa1f5127a789165dfe9ff140ec0d6e scipy-0.19.0-cp27-cp27mu-manylinux1_x86_64.whl d568c9f60683c33b81ebc1c39eea198a scipy-0.19.0-cp34-cp34m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl a90148fec477c1950578b40a1197509f scipy-0.19.0-cp34-cp34m-manylinux1_i686.whl ed27be5380e0aaf0229adf747e760f8c scipy-0.19.0-cp34-cp34m-manylinux1_x86_64.whl 4cda63dc7b73bd03bdf9e8ebc6027526 scipy-0.19.0-cp35-cp35m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl ff8e652b5e918b276793f1ce542a5959 scipy-0.19.0-cp35-cp35m-manylinux1_i686.whl 60741a900a145eb924ec861ec2743582 scipy-0.19.0-cp35-cp35m-manylinux1_x86_64.whl 81685a961d6118459b7787e8465c8d36 scipy-0.19.0-cp36-cp36m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl 83f0750862c80a659686797d4ec9bca0 scipy-0.19.0-cp36-cp36m-manylinux1_i686.whl 3cbb30615496fbbf9b52c9a643c6fe5e scipy-0.19.0-cp36-cp36m-manylinux1_x86_64.whl 735cdb6fbfcb9917535749816202d0af scipy-0.19.0.tar.gz b21466e87a642940fb9ba35be74940a3 scipy-0.19.0.tar.xz 91b8396231eec780222a57703d3ec550 scipy-0.19.0.zip SHA256 ~~~~~~ 517a85600d6574fef1a67e6d2001b847c27c8bfd136f7a12879c3f91e7bb291f scipy-0.19.0-cp27-cp27m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl 3c34987ee52fd98b34f2e4a6d277b452d49056f1383550acc54c5bab408a194c scipy-0.19.0-cp27-cp27m-manylinux1_i686.whl eabdfde8276007e9aec9a400f9528645001a30f7d78b04a0ab215183d9523e2a scipy-0.19.0-cp27-cp27m-manylinux1_x86_64.whl fa67bbb0a3225fcd8610d693e7b2ca08fda107359e48229f7b83593bbb70cc97 scipy-0.19.0-cp27-cp27mu-manylinux1_i686.whl 4147b97709e75822e73d312e4d262410baafa961a7b11649a7b4b7c2d41fb4fe scipy-0.19.0-cp27-cp27mu-manylinux1_x86_64.whl 663e78bfa197376547424aff9fb5009e7b2f26855ee5aaf1a2ddbb2f4dc6af3b scipy-0.19.0-cp34-cp34m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl 2e70ded029d51f6a48d4b2a154f583b85aa2e3290dfd71e0b6bbcfe9454cffdd scipy-0.19.0-cp34-cp34m-manylinux1_i686.whl 4b2731a191dfa48a05b2f5bc18881595a1418092092ecdd8d3feab80f72adc96 scipy-0.19.0-cp34-cp34m-manylinux1_x86_64.whl 57f7be33f1009ad6199132e8a7e5d4c9727224680d8cbc4596a2a8935a86f96b scipy-0.19.0-cp35-cp35m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl 0496f2b204a63cde3797e5452bf671ee25afc11bd9489ae69cd4dccee13083a1 scipy-0.19.0-cp35-cp35m-manylinux1_i686.whl 1bcf71f2e534a1aabf9f075700701bf3af434120b1b114dfa4723d02e076ed1f scipy-0.19.0-cp35-cp35m-manylinux1_x86_64.whl e1c45905f550b5f14e1f47697c92bab5c1e6ba77da5a441bd2affa4621c41b26 scipy-0.19.0-cp36-cp36m-macosx_10_6_intel.macosx_10_9_intel.macosx_10_9_x86_64.macosx_10_10_intel.macosx_10_10_x86_64.whl 47f537214293a5d74b05d217afa49b582b7fd9428ec9ea64be69210cfc56611a scipy-0.19.0-cp36-cp36m-manylinux1_i686.whl f5a3a7dcbeb345c227770029870aeb547a3c207a6cbc0106d6157139fd0c23e9 scipy-0.19.0-cp36-cp36m-manylinux1_x86_64.whl eba12b5f757a8c839b26a06f4936ecb80b65cb3674981ee25449b2a55663abe8 scipy-0.19.0.tar.gz ed52232afb2b321a4978e39040d94bf81af90176ba64f58c4499dc305a024437 scipy-0.19.0.tar.xz 4190d34bf9a09626cd42100bbb12e3d96b2daf1a8a3244e991263eb693732122 scipy-0.19.0.zip -----BEGIN PGP SIGNATURE----- Version: GnuPG v1.4.11 (GNU/Linux) iQEcBAEBCAAGBQJYwWscAAoJEIp0pQ0zQcu+JG8H+gOy04ecVl+IBisy/Fz5wfuy xrsCT5yhRPQpxKph8g/6Us5Oh7s8ixrVt9gTVccAspmWXQJhMy5kcppC3s5WsvU+ jFOwUnW7c9QvtIf2ZD9Ay/56WojlXg1ui17MqoCbmkEn2QE8KTKu93hIZpVD5wmV 1fhd7u/ieeQ7sfj6gMZzt0AGpVjnGedEzHRY4zI0PkiCY+Ex8sc2W8G2h5Qbnx9r KoqECIuesLQzVbNgPhWaWaiE1TNX0EJYdWQll0T8scI4opUdg6vEaR05aPhxeR1r KaGEnvfASTZ369COkuVB4JINlKQj0dwLBFIr9NGVzX4vU74GMh5TuDfJlA/mvGU= =bOnA -----END PGP SIGNATURE----- From rays at blue-cove.com Thu Mar 9 11:29:16 2017 From: rays at blue-cove.com (R Schumacher) Date: Thu, 09 Mar 2017 08:29:16 -0800 Subject: [SciPy-User] ANN: SciPy 0.19.0 In-Reply-To: References: Message-ID: <201703091630.v29GU0Hf019131@blue-cove.com> Excellent. We are working with DSP32C legacy data, and of course it is not a native type. The original C code is no longer available so this is our numpy implementation... Might there be a "better" method to support the AT&T format? def dsp32c_to_float(bytes): dsp32c_array = np.frombuffer(bytes, np.int32) signed = dsp32c_array & 0x80000000 > 0 exponent = (dsp32c_array & 0x000000ff) << 23 mantissa = (dsp32c_array & 0x7fffffff) >> 8 mantissa[signed] = 0x80000000 + ~mantissa[signed] ieee_array = exponent + mantissa float_array = ieee_array.view('f') return float_array Of course if anyone out there has a stashed copy of dsptools.c void ieeetodspf( float *x); void dspftoieee( float *x); http://www.symres.com/files/legacy/mandsp.pdf it would go a long way... At 07:54 AM 3/9/2017, you wrote: >Content-Transfer-Encoding: 8bit > >On behalf of the Scipy development team I am pleased to announce the >availability of Scipy 0.19.0. This release contains several great new >features and a large number of bug fixes and various improvements, as >detailed in the release notes below. >121 people contributed to this release over the course of seven months. Ray Schumacher -------------- next part -------------- An HTML attachment was scrubbed... URL: From jslavin at cfa.harvard.edu Fri Mar 10 12:17:25 2017 From: jslavin at cfa.harvard.edu (Slavin, Jonathan) Date: Fri, 10 Mar 2017 12:17:25 -0500 Subject: [SciPy-User] AT&T format Message-ID: ?Have you looked at the python library struct? I don't know anything about the AT&T format but I have been able to read Fortran unformatted data using it. It depends on knowing the number of padding bytes on each line, etc. Anyways, could be useful. Jon? On Fri, Mar 10, 2017 at 12:00 PM, wrote: > Date: Thu, 09 Mar 2017 08:29:16 -0800 > From: R Schumacher > To: SciPy Users List > Subject: Re: [SciPy-User] ANN: SciPy 0.19.0 > Message-ID: <201703091630.v29GU0Hf019131 at blue-cove.com> > Content-Type: text/plain; charset="us-ascii"; Format="flowed" > > Excellent. > > We are working with DSP32C legacy data, and of course it is not a > native type. The original C code is no longer available so this is > our numpy implementation... > Might there be a "better" method to support the AT&T format? > > def dsp32c_to_float(bytes): > dsp32c_array = np.frombuffer(bytes, np.int32) > signed = dsp32c_array & 0x80000000 > 0 > exponent = (dsp32c_array & 0x000000ff) << 23 > mantissa = (dsp32c_array & 0x7fffffff) >> 8 > mantissa[signed] = 0x80000000 + ~mantissa[signed] > ieee_array = exponent + mantissa > float_array = ieee_array.view('f') > return float_array > > Of course if anyone out there has a stashed copy of dsptools.c > void ieeetodspf( float *x); > void dspftoieee( float *x); > http://www.symres.com/files/legacy/mandsp.pdf > it would go a long way... > > -- ________________________________________________________ Jonathan D. Slavin Harvard-Smithsonian CfA jslavin at cfa.harvard.edu 60 Garden Street, MS 83 phone: (617) 496-7981 Cambridge, MA 02138-1516 cell: (781) 363-0035 USA ________________________________________________________ -------------- next part -------------- An HTML attachment was scrubbed... URL: From damon.mcdougall at gmail.com Sat Mar 11 13:56:06 2017 From: damon.mcdougall at gmail.com (Damon McDougall) Date: Sat, 11 Mar 2017 12:56:06 -0600 Subject: [SciPy-User] ANN: Scientific Software Days Conference, April 2017 Message-ID: <1489258566.1358543.908104624.578D7CF5@webmail.messagingengine.com> I thought folks here might find interest in this, but let me know if it's inappropriate to post this here: Registration is open for the 8th Annual Scientific Software Days conference. Register here: http://scisoftdays.org/ The 8th Annual Scientific Software Days Conference (SSD) targets users and developers of scientific software. The conference will be held at the University of Texas at Austin Thursday Apr 27 - Friday Apr 28, 2017 and focuses on two themes: a) sharing best practices across scientific software communities; b) sharing the latest tools and technology relevant to scientific software. So far the following speakers have confirmed: Beatrice Riviere (keynote, Rice) Mark Hoemmen (keynote, Sandia National Laboratories) Sherry Li (Lawrence Berkeley National Laboratory) Wolfgang Bangerth (Colorado State University) Dan Negrut (University of Wisconsin-Madison) Chris Simmons (UT Austin) Jim Bowring (College of Charleston) Questions can be directed to ssd-organizers at googlegroups.com. Limited travel funding is available for participants from underrepresented groups, students and early career researchers. Register online here: http://scisoftdays.org/ From charlesr.harris at gmail.com Sat Mar 18 13:57:28 2017 From: charlesr.harris at gmail.com (Charles R Harris) Date: Sat, 18 Mar 2017 11:57:28 -0600 Subject: [SciPy-User] NumPy 1.12.1 released Message-ID: Hi All, I'm pleased to announce the release of NumPy 1.12.1. NumPy 1.12.1 supports Python 2.7 and 3.4 - 3.6 and fixes bugs and regressions found in NumPy 1.12.0. In particular, the regression in f2py constant parsing is fixed. Wheels for Linux, Windows, and OSX can be found on pypi. Archives can be downloaded from github . *Contributors* A total of 10 people contributed to this release. People with a "+" by their names contributed a patch for the first time. * Charles Harris * Eric Wieser * Greg Young * Joerg Behrmann + * John Kirkham * Julian Taylor * Marten van Kerkwijk * Matthew Brett * Shota Kawabuchi * Jean Utke + *Fixes Backported* * #8483: BUG: Fix wrong future nat warning and equiv type logic error... * #8489: BUG: Fix wrong masked median for some special cases * #8490: DOC: Place np.average in inline code * #8491: TST: Work around isfinite inconsistency on i386 * #8494: BUG: Guard against replacing constants without `'_'` spec in f2py. * #8524: BUG: Fix mean for float 16 non-array inputs for 1.12 * #8571: BUG: Fix calling python api with error set and minor leaks for... * #8602: BUG: Make iscomplexobj compatible with custom dtypes again * #8618: BUG: Fix undefined behaviour induced by bad `__array_wrap__` * #8648: BUG: Fix `MaskedArray.__setitem__` * #8659: BUG: PPC64el machines are POWER for Fortran in f2py * #8665: BUG: Look up methods on MaskedArray in `_frommethod` * #8674: BUG: Remove extra digit in `binary_repr` at limit * #8704: BUG: Fix deepcopy regression for empty arrays. * #8707: BUG: Fix ma.median for empty ndarrays Cheers, Chuck -------------- next part -------------- An HTML attachment was scrubbed... URL: From edwardlrichards at gmail.com Sat Mar 18 16:08:51 2017 From: edwardlrichards at gmail.com (Edward Richards) Date: Sat, 18 Mar 2017 13:08:51 -0700 Subject: [SciPy-User] Is a worked paper example appropriate for documentation? Message-ID: <58CD93D3.7070007@gmail.com> I am wondering if simple recipes for recreating paper figures are appropriate for documentation, and if so, where should they be put? I have code to recreate figure 1 from E T Y Lee's paper "Choosing nodes in parametric curve interpolation" (doi: 0010448589900031). I know very little about interpolation, but I worked this example because of the response to mathematica SE question # 10273. It seems to me like a good exploration of some of the more esoteric features of interpolation, and it spans a number of separate scipy.interpolate functions. Would adding code like this help or clutter existing documentation? As a side note I feel that I am late to the party for missing by Docathon a week. Thanks, Ned import numpy as np import matplotlib.pyplot as plt from scipy.interpolate import splprep, splev, CubicSpline p = np.array([[0, 26, 28, 54], [0, 24, 24, 0]]) dp = np.diff(p, axis=-1) def parametic_nodes(escale): """Compute parametric knots location""" t = np.hstack((0, np.cumsum(np.linalg.norm(dp, axis=0) ** escale))) return t / np.max(t) us = np.arange(201) / 200 fig, ax = plt.subplots(2,2) ax[0, 0].plot(*splev(us, splprep(p, u=np.arange(4) / 3, s=0)[0])) ax[0, 0].plot(*splev(us, splprep(p, u=p[0, :] / 54, s=0)[0])) ax[0, 0].plot(*splev(us, splprep(p, u=parametic_nodes(1), s=0)[0])) ax[0, 1].plot(*splev(us, splprep(p, u=parametic_nodes(0), s=0)[0])) ax[0, 1].plot(*splev(us, splprep(p, u=parametic_nodes(0.5), s=0)[0])) ax[0, 1].plot(*splev(us, splprep(p, u=parametic_nodes(1), s=0)[0])) ax[1, 0].plot(*splev(us, splprep(p, u=parametic_nodes(0.35), s=0)[0])) ax[1, 0].plot(*splev(us, splprep(p, u=parametic_nodes(0.5), s=0)[0])) ax[1, 0].plot(*splev(us, splprep(p, u=parametic_nodes(0.65), s=0)[0])) ax[1, 1].plot(*CubicSpline(np.arange(4) / 3, p.T, bc_type='natural')(us).T) ax[1, 1].plot(*CubicSpline(parametic_nodes(0.5), p.T, bc_type='natural')(us).T) ax[1, 1].plot(*CubicSpline(parametic_nodes(1), p.T, bc_type='natural')(us).T) plt.show(block=False) From stevenbocco at gmail.com Tue Mar 21 12:08:35 2017 From: stevenbocco at gmail.com (Steven Bocco) Date: Tue, 21 Mar 2017 12:08:35 -0400 Subject: [SciPy-User] Announcing Theano 0.9.0 Message-ID: Announcing Theano 0.9.0 This is a release for a major version, with lots of new features, bug fixes, and some interface changes (deprecated or potentially misleading features were removed). This release is the last major version that features the old GPU back-end ( theano.sandbox.cuda, accessible through device=gpu*). All GPU users are encouraged to transition to the new GPU back-end, based on libgpuarray ( theano.gpuarray, accessible through device=cuda*). For more information, see https://github.com/Theano/Theano/wiki/Converting-to-the-new-gpu-back-end%28gpuarray%29 . Upgrading to Theano 0.9.0 is recommended for everyone, but you should first make sure that your code does not raise deprecation warnings with Theano 0.8*. Otherwise either results can change, or warnings may have been turned into errors. For those using the bleeding edge version in the git repository, we encourage you to update to the rel-0.9.0 tag. What's New Highlights (since 0.8.0): - Better Python 3.5 support - Better numpy 1.12 support - Conda packages for Mac, Linux and Windows - Support newer Mac and Windows versions - More Windows integration: - Theano scripts (theano-cache and theano-nose) now works on Windows - Better support for Windows end-lines into C codes - Support for space in paths on Windows - Scan improvements: - More scan optimizations, with faster compilation and gradient computation - Support for checkpoint in scan (trade off between speed and memory usage, useful for long sequences) - Fixed broadcast checking in scan - Graphs improvements: - More numerical stability by default for some graphs - Better handling of corner cases for theano functions and graph optimizations - More graph optimizations with faster compilation and execution - smaller and more readable graph - New GPU back-end: - Removed warp-synchronous programming to get good results with newer CUDA drivers - More pooling support on GPU when cuDNN isn't available - Full support of ignore_border option for pooling - Inplace storage for shared variables - float16 storage - Using PCI bus ID of graphic cards for a better mapping between theano device number and nvidia-smi number - Fixed offset error in GpuIncSubtensor - Less C code compilation - Added support for bool dtype - Updated and more complete documentation - Bug fixes related to merge optimizer and shape inference - Lot of other bug fixes, crashes fixes and warning improvements Interface changes: - Merged CumsumOp/CumprodOp into CumOp - In MRG module: - Replaced method multinomial_wo_replacement() with new method choice() - Random generator now tries to infer the broadcast pattern of its output - New pooling interface - Pooling parameters can change at run time - Moved softsign out of sandbox to theano.tensor.nnet.softsign - Using floatX dtype when converting empty list/tuple - Roll make the shift be modulo the size of the axis we roll on - round() default to the same as NumPy: half_to_even Convolution updates: - Support of full and half modes for 2D and 3D convolutions including in conv3d2d - Allowed pooling of empty batch - Implement conv2d_transpose convenience function - Multi-cores convolution and pooling on CPU - New abstract 3d convolution interface similar to the 2d convolution interface - Dilated convolution GPU: - cuDNN: support versoin 5.1 and wrap batch normalization (2d and 3d) and RNN functions - Multiple-GPU, synchrone update (via platoon, use NCCL) - Gemv(matrix-vector product) speed up for special shape - cublas gemv workaround when we reduce on an axis with a dimensions size of 0 - Warn user that some cuDNN algorithms may produce unexpected results in certain environments for convolution backward filter operations - GPUMultinomialFromUniform op now supports multiple dtypes - Support for MaxAndArgMax for some axis combination - Support for solve (using cusolver), erfinv and erfcinv - Implemented GpuAdvancedSubtensor New features: - OpFromGraph now allows gradient overriding for every input - Added Abstract Ops for batch normalization that use cuDNN when available and pure Theano CPU/GPU alternatives otherwise - Added gradient of solve, tensorinv (CPU), tensorsolve (CPU), searchsorted (CPU), DownsampleFactorMaxGradGrad (CPU) - Added Multinomial Without Replacement - Allowed partial evaluation of compiled function - More Rop support - Indexing support ellipsis: a[..., 3]`, a[1,...,3] - Added theano.tensor.{tensor5,dtensor5, ...} - compiledir_format support device - Added New Theano flag conv.assert_shape to check user-provided shapes at runtime (for debugging) - Added new Theano flag cmodule.age_thresh_use - Added new Theano flag cuda.enabled - Added new Theano flag nvcc.cudafe to enable faster compilation and import with old CUDA back-end - Added new Theano flag print_global_stats to print some global statistics (time spent) at the end - Added new Theano flag profiling.ignore_first_call, useful to profile the new gpu back-end - remove ProfileMode (use Theano flag profile=True instead) Others: - Split op now has C code for CPU and GPU - theano-cache list now includes compilation times - Speed up argmax only on GPU (without also needing the max) - More stack trace in error messages - Speed up cholesky grad - log(sum(exp(...))) now get stability optimized Other more detailed changes: - Added Jenkins (gpu tests run on pull requests in addition to daily buildbot) - Removed old benchmark directory and other old files not used anymore - Use of 64-bit indexing in sparse ops to allow matrix with more then 231-1 elements - Allowed more then one output to be an destructive inplace - More support of negative axis - Added the keepdims parameter to the norm function - Make scan gradient more deterministic Download and Install You can download Theano from http://pypi.python.org/pypi/Theano Installation instructions are available at http://deeplearning.net/software/theano/install.html Description Theano is a Python library that allows you to define, optimize, and efficiently evaluate mathematical expressions involving multi-dimensional arrays. It is built on top of NumPy. Theano features: - tight integration with NumPy: a similar interface to NumPy's. numpy.ndarrays are also used internally in Theano-compiled functions. - transparent use of a GPU: perform data-intensive computations much faster than on a CPU. - efficient symbolic differentiation: Theano can compute derivatives for functions of one or many inputs. - speed and stability optimizations: avoid nasty bugs when computing expressions such as log(1+ exp(x)) for large values of x. - dynamic C code generation: evaluate expressions faster. - extensive unit-testing and self-verification: includes tools for detecting and diagnosing bugs and/or potential problems. Theano has been powering large-scale computationally intensive scientific research since 2007, but it is also approachable enough to be used in the classroom (IFT6266 at the University of Montreal). Resources About Theano: http://deeplearning.net/software/theano/ Theano-related projects: http://github.com/Theano/Theano/wiki/Related-projects About NumPy: http://numpy.scipy.org/ About SciPy: http://www.scipy.org/ Machine Learning Tutorial with Theano on Deep Architectures: http://deeplearning.net/tutorial/ Acknowledgments I would like to thank all contributors of Theano. For this particular release, many people have helped, notably (in alphabetical order): - affanv14 - Alexander Matyasko - Alexandre de Brebisson - Amjad Almahairi - Andr?s Gottlieb - Anton Chechetka - Arnaud Bergeron - Benjamin Scellier - Ben Poole - Bhavishya Pohani - Bryn Keller - Caglar - Carl Thom? - Cesar Laurent - Chiheb Trabelsi - Chinnadhurai Sankar - Christos Tsirigotis - Ciyong Chen - David Bau - Dimitar Dimitrov - Evelyn Mitchell - F?bio Perez - Faruk Ahmed - Fei Wang - Fei Zhan - Florian Bordes - Francesco Visin - Frederic Bastien - Fuchai - Gennadiy Tupitsin - Gijs van Tulder - Gilles Louppe - Gokula Krishnan - Greg Ciccarelli - gw0 [http://gw.tnode.com/] - happygds - Harm de Vries - He - hexahedria - hsintone - Huan Zhang - Ilya Kulikov - Iulian Vlad Serban - jakirkham - Jakub Sygnowski - Jan Schl?ter - Jesse Livezey - Jonas Degrave - joncrall - Kaixhin - Karthik Karanth - Kelvin Xu - Kevin Keraudren - khaotik - Kirill Bobyrev - Kumar Krishna Agrawal - Kv Manohar - Liwei Cai - Lucas Beyer - Maltimore - Marc-Alexandre Cote - Marco - Marius F. Killinger - Martin Drawitsch - Mathieu Germain - Matt Graham - Maxim Kochurov - Micah Bojrab - Michael Harradon - Mikhail Korobov - mockingjamie - Mohammad Pezeshki - Morgan Stuart - Nan Rosemary Ke - Neil - Nicolas Ballas - Nizar Assaf - Olivier Mastropietro - Ozan ?a?layan - p - Pascal Lamblin - Pierre Luc Carrier - RadhikaG - Ramana Subramanyam - Ray Donnelly - Rebecca N. Palmer - Reyhane Askari - Rithesh Kumar - Rizky Luthfianto - Robin Millette - Roman Ring - root - Ruslana Makovetsky - Saizheng Zhang - Samira Ebrahimi Kahou - Samira Shabanian - Sander Dieleman - Sebastin Santy - Shawn Tan - Simon Lefrancois - Sina Honari - Steven Bocco - superantichrist - Taesup (TS) Kim - texot - Thomas George - tillahoffmann - Tim Cooijmans - Tim Gasper - valtron - Vincent Dumoulin - Vincent Michalski - Vitaliy Kurlin - Wazeer Zulfikar - wazeerzulfikar - Wojciech G?ogowski - Xavier Bouthillier - Yang Zhang - Yann N. Dauphin - Yaroslav Ganin - Ying Zhang - you-n-g - Zhouhan LIN Also, thank you to all NumPy and Scipy developers as Theano builds on their strengths. All questions/comments are always welcome on the Theano mailing-lists ( http://deeplearning.net/software/theano/#community ) -------------- next part -------------- An HTML attachment was scrubbed... URL: From ralf.gommers at gmail.com Wed Mar 22 05:23:15 2017 From: ralf.gommers at gmail.com (Ralf Gommers) Date: Wed, 22 Mar 2017 22:23:15 +1300 Subject: [SciPy-User] migration of all scipy.org mailing lists Message-ID: Hi all, The server for the scipy.org mailing list is in very bad shape, so we (led by Didrik Pinte) are planning to complete the migration of active mailing lists to the python.org infrastructure and to decommission the lists than seem dormant/obsolete. The scipy-user mailing list was already moved to python.org a month or two ago, and that migration went smoothly. These are the lists we plan to migrate: astropy ipython-dev ipython-user numpy-discussion numpy-svn scipy-dev scipy-organizers scipy-svn And these we plan to retire: Announce APUG Ipython-tickets Mailman numpy-refactor numpy-refactor-git numpy-tickets Pyxg scipy-tickets NiPy-devel There will be a short period (<24 hours) where messages to the list may be refused, with an informative message as to why. The mailing list address will change from listname at scipy.org to listname at python.org This will happen asap, likely within a day or two. So two requests: 1. If you see any issue with this plan, please reply and keep Didrik and myself on Cc (we are not subscribed to all lists). 2. If you see this message on a numpy/scipy list, but not on another list (could be due to a moderation queue) then please forward this message again to that other list. Thanks, Ralf -------------- next part -------------- An HTML attachment was scrubbed... URL: From ralf.gommers at gmail.com Wed Mar 22 05:24:37 2017 From: ralf.gommers at gmail.com (Ralf Gommers) Date: Wed, 22 Mar 2017 22:24:37 +1300 Subject: [SciPy-User] migration of all scipy.org mailing lists In-Reply-To: References: Message-ID: (and now with Didrik on Cc - apologies) On Wed, Mar 22, 2017 at 10:23 PM, Ralf Gommers wrote: > Hi all, > > The server for the scipy.org mailing list is in very bad shape, so we > (led by Didrik Pinte) are planning to complete the migration of active > mailing lists to the python.org infrastructure and to decommission the > lists than seem dormant/obsolete. > > The scipy-user mailing list was already moved to python.org a month or > two ago, and that migration went smoothly. > > These are the lists we plan to migrate: > > astropy > ipython-dev > ipython-user > numpy-discussion > numpy-svn > scipy-dev > scipy-organizers > scipy-svn > > And these we plan to retire: > > Announce > APUG > Ipython-tickets > Mailman > numpy-refactor > numpy-refactor-git > numpy-tickets > Pyxg > scipy-tickets > NiPy-devel > > There will be a short period (<24 hours) where messages to the list may be > refused, with an informative message as to why. The mailing list address > will change from listname at scipy.org to listname at python.org > > This will happen asap, likely within a day or two. So two requests: > 1. If you see any issue with this plan, please reply and keep Didrik and > myself on Cc (we are not subscribed to all lists). > 2. If you see this message on a numpy/scipy list, but not on another list > (could be due to a moderation queue) then please forward this message again > to that other list. > > Thanks, > Ralf > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From stevenbocco at gmail.com Tue Mar 21 11:05:36 2017 From: stevenbocco at gmail.com (Steven Bocco) Date: Tue, 21 Mar 2017 11:05:36 -0400 Subject: [SciPy-User] Announcing Theano 0.9.0 Message-ID: Announcing Theano 0.9.0 This is a release for a major version, with lots of new features, bug fixes, and some interface changes (deprecated or potentially misleading features were removed). This release is the last major version that features the old GPU back-end ( theano.sandbox.cuda, accessible through device=gpu*). All GPU users are encouraged to transition to the new GPU back-end, based on libgpuarray ( theano.gpuarray, accessible through device=cuda*). For more information, see https://github.com/Theano/Theano/wiki/Converting-to-the-new-gpu-back-end%28gpuarray%29 . Upgrading to Theano 0.9.0 is recommended for everyone, but you should first make sure that your code does not raise deprecation warnings with Theano 0.8*. Otherwise either results can change, or warnings may have been turned into errors. For those using the bleeding edge version in the git repository, we encourage you to update to the rel-0.9.0 tag. What's New Highlights (since 0.8.0): - Better Python 3.5 support - Better numpy 1.12 support - Conda packages for Mac, Linux and Windows - Support newer Mac and Windows versions - More Windows integration: - Theano scripts (theano-cache and theano-nose) now works on Windows - Better support for Windows end-lines into C codes - Support for space in paths on Windows - Scan improvements: - More scan optimizations, with faster compilation and gradient computation - Support for checkpoint in scan (trade off between speed and memory usage, useful for long sequences) - Fixed broadcast checking in scan - Graphs improvements: - More numerical stability by default for some graphs - Better handling of corner cases for theano functions and graph optimizations - More graph optimizations with faster compilation and execution - smaller and more readable graph - New GPU back-end: - Removed warp-synchronous programming to get good results with newer CUDA drivers - More pooling support on GPU when cuDNN isn't available - Full support of ignore_border option for pooling - Inplace storage for shared variables - float16 storage - Using PCI bus ID of graphic cards for a better mapping between theano device number and nvidia-smi number - Fixed offset error in GpuIncSubtensor - Less C code compilation - Added support for bool dtype - Updated and more complete documentation - Bug fixes related to merge optimizer and shape inference - Lot of other bug fixes, crashes fixes and warning improvements Interface changes: - Merged CumsumOp/CumprodOp into CumOp - In MRG module: - Replaced method multinomial_wo_replacement() with new method choice() - Random generator now tries to infer the broadcast pattern of its output - New pooling interface - Pooling parameters can change at run time - Moved softsign out of sandbox to theano.tensor.nnet.softsign - Using floatX dtype when converting empty list/tuple - Roll make the shift be modulo the size of the axis we roll on - round() default to the same as NumPy: half_to_even Convolution updates: - Support of full and half modes for 2D and 3D convolutions including in conv3d2d - Allowed pooling of empty batch - Implement conv2d_transpose convenience function - Multi-cores convolution and pooling on CPU - New abstract 3d convolution interface similar to the 2d convolution interface - Dilated convolution GPU: - cuDNN: support versoin 5.1 and wrap batch normalization (2d and 3d) and RNN functions - Multiple-GPU, synchrone update (via platoon, use NCCL) - Gemv(matrix-vector product) speed up for special shape - cublas gemv workaround when we reduce on an axis with a dimensions size of 0 - Warn user that some cuDNN algorithms may produce unexpected results in certain environments for convolution backward filter operations - GPUMultinomialFromUniform op now supports multiple dtypes - Support for MaxAndArgMax for some axis combination - Support for solve (using cusolver), erfinv and erfcinv - Implemented GpuAdvancedSubtensor New features: - OpFromGraph now allows gradient overriding for every input - Added Abstract Ops for batch normalization that use cuDNN when available and pure Theano CPU/GPU alternatives otherwise - Added gradient of solve, tensorinv (CPU), tensorsolve (CPU), searchsorted (CPU), DownsampleFactorMaxGradGrad (CPU) - Added Multinomial Without Replacement - Allowed partial evaluation of compiled function - More Rop support - Indexing support ellipsis: a[..., 3]`, a[1,...,3] - Added theano.tensor.{tensor5,dtensor5, ...} - compiledir_format support device - Added New Theano flag conv.assert_shape to check user-provided shapes at runtime (for debugging) - Added new Theano flag cmodule.age_thresh_use - Added new Theano flag cuda.enabled - Added new Theano flag nvcc.cudafe to enable faster compilation and import with old CUDA back-end - Added new Theano flag print_global_stats to print some global statistics (time spent) at the end - Added new Theano flag profiling.ignore_first_call, useful to profile the new gpu back-end - remove ProfileMode (use Theano flag profile=True instead) Others: - Split op now has C code for CPU and GPU - theano-cache list now includes compilation times - Speed up argmax only on GPU (without also needing the max) - More stack trace in error messages - Speed up cholesky grad - log(sum(exp(...))) now get stability optimized Other more detailed changes: - Added Jenkins (gpu tests run on pull requests in addition to daily buildbot) - Removed old benchmark directory and other old files not used anymore - Use of 64-bit indexing in sparse ops to allow matrix with more then 231-1 elements - Allowed more then one output to be an destructive inplace - More support of negative axis - Added the keepdims parameter to the norm function - Make scan gradient more deterministic Download and Install You can download Theano from http://pypi.python.org/pypi/Theano Installation instructions are available at http://deeplearning.net/software/theano/install.html Description Theano is a Python library that allows you to define, optimize, and efficiently evaluate mathematical expressions involving multi-dimensional arrays. It is built on top of NumPy. Theano features: - tight integration with NumPy: a similar interface to NumPy's. numpy.ndarrays are also used internally in Theano-compiled functions. - transparent use of a GPU: perform data-intensive computations much faster than on a CPU. - efficient symbolic differentiation: Theano can compute derivatives for functions of one or many inputs. - speed and stability optimizations: avoid nasty bugs when computing expressions such as log(1+ exp(x)) for large values of x. - dynamic C code generation: evaluate expressions faster. - extensive unit-testing and self-verification: includes tools for detecting and diagnosing bugs and/or potential problems. Theano has been powering large-scale computationally intensive scientific research since 2007, but it is also approachable enough to be used in the classroom (IFT6266 at the University of Montreal). Resources About Theano: http://deeplearning.net/software/theano/ Theano-related projects: http://github.com/Theano/Theano/wiki/Related-projects About NumPy: http://numpy.scipy.org/ About SciPy: http://www.scipy.org/ Machine Learning Tutorial with Theano on Deep Architectures: http://deeplearning.net/tutorial/ Acknowledgments I would like to thank all contributors of Theano. For this particular release, many people have helped, notably (in alphabetical order): - affanv14 - Alexander Matyasko - Alexandre de Brebisson - Amjad Almahairi - Andr?s Gottlieb - Anton Chechetka - Arnaud Bergeron - Benjamin Scellier - Ben Poole - Bhavishya Pohani - Bryn Keller - Caglar - Carl Thom? - Cesar Laurent - Chiheb Trabelsi - Chinnadhurai Sankar - Christos Tsirigotis - Ciyong Chen - David Bau - Dimitar Dimitrov - Evelyn Mitchell - F?bio Perez - Faruk Ahmed - Fei Wang - Fei Zhan - Florian Bordes - Francesco Visin - Frederic Bastien - Fuchai - Gennadiy Tupitsin - Gijs van Tulder - Gilles Louppe - Gokula Krishnan - Greg Ciccarelli - gw0 [http://gw.tnode.com/] - happygds - Harm de Vries - He - hexahedria - hsintone - Huan Zhang - Ilya Kulikov - Iulian Vlad Serban - jakirkham - Jakub Sygnowski - Jan Schl?ter - Jesse Livezey - Jonas Degrave - joncrall - Kaixhin - Karthik Karanth - Kelvin Xu - Kevin Keraudren - khaotik - Kirill Bobyrev - Kumar Krishna Agrawal - Kv Manohar - Liwei Cai - Lucas Beyer - Maltimore - Marc-Alexandre Cote - Marco - Marius F. Killinger - Martin Drawitsch - Mathieu Germain - Matt Graham - Maxim Kochurov - Micah Bojrab - Michael Harradon - Mikhail Korobov - mockingjamie - Mohammad Pezeshki - Morgan Stuart - Nan Rosemary Ke - Neil - Nicolas Ballas - Nizar Assaf - Olivier Mastropietro - Ozan ?a?layan - p - Pascal Lamblin - Pierre Luc Carrier - RadhikaG - Ramana Subramanyam - Ray Donnelly - Rebecca N. Palmer - Reyhane Askari - Rithesh Kumar - Rizky Luthfianto - Robin Millette - Roman Ring - root - Ruslana Makovetsky - Saizheng Zhang - Samira Ebrahimi Kahou - Samira Shabanian - Sander Dieleman - Sebastin Santy - Shawn Tan - Simon Lefrancois - Sina Honari - Steven Bocco - superantichrist - Taesup (TS) Kim - texot - Thomas George - tillahoffmann - Tim Cooijmans - Tim Gasper - valtron - Vincent Dumoulin - Vincent Michalski - Vitaliy Kurlin - Wazeer Zulfikar - wazeerzulfikar - Wojciech G?ogowski - Xavier Bouthillier - Yang Zhang - Yann N. Dauphin - Yaroslav Ganin - Ying Zhang - you-n-g - Zhouhan LIN Also, thank you to all NumPy and Scipy developers as Theano builds on their strengths. All questions/comments are always welcome on the Theano mailing-lists ( http://deeplearning.net/software/theano/#community ) -------------- next part -------------- An HTML attachment was scrubbed... URL: From ralf.gommers at gmail.com Wed Mar 22 05:13:54 2017 From: ralf.gommers at gmail.com (Ralf Gommers) Date: Wed, 22 Mar 2017 22:13:54 +1300 Subject: [SciPy-User] migration of all scipy.org mailing lists Message-ID: Hi all, The server for the scipy.org mailing list is in very bad shape, so we (led by Didrik Pinte) are planning to complete the migration of active mailing lists to the python.org infrastructure and to decommission the lists than seem dormant/obsolete. The scipy-user mailing list was already moved to python.org a month or two ago, and that migration went smoothly. These are the lists we plan to migrate: astropy ipython-dev ipython-user numpy-discussion numpy-svn scipy-dev scipy-organizers scipy-svn And these we plan to retire: Announce APUG Ipython-tickets Mailman numpy-refactor numpy-refactor-git numpy-tickets Pyxg scipy-tickets NiPy-devel This will happen asap, likely within a day or two. So two requests: 1. If you see any issue with this plan, please reply and keep Didrik and myself on Cc (we are not subscribed to all lists). 2. If you see this message on a numpy/scipy list, but not on another list (could be due to a moderation queue) then please forward this message again to that other list. Thanks, Ralf -------------- next part -------------- An HTML attachment was scrubbed... URL: From npropadovic at gmail.com Wed Mar 22 09:35:25 2017 From: npropadovic at gmail.com (Propadovic Nenad) Date: Wed, 22 Mar 2017 14:35:25 +0100 Subject: [SciPy-User] migration of all scipy.org Message-ID: Hello, I'd just like to add that it's important to point to the new lists from scipy.org as soon as possible. When I searched the scipy mailing list some two months ago, I was pointed to the one at scipy.org and found myself wondering how comes that the last message is from November last year. It took some time to realize that the last message announces the migration to the new list... Besides: "explicit is better than implicit" ... Cheers, Nenad -------------- next part -------------- An HTML attachment was scrubbed... URL: From ralf.gommers at gmail.com Thu Mar 23 05:52:05 2017 From: ralf.gommers at gmail.com (Ralf Gommers) Date: Thu, 23 Mar 2017 22:52:05 +1300 Subject: [SciPy-User] migration of all scipy.org In-Reply-To: References: Message-ID: On Thu, Mar 23, 2017 at 2:35 AM, Propadovic Nenad wrote: > Hello, > I'd just like to add that it's important to point to the new lists from > scipy.org as soon as possible. > When I searched the scipy mailing list some two months ago, I was pointed > to the one at scipy.org > Where did you find that outdated link, and does it still need fixing? Our own page on that is https://scipy.org/scipylib/mailing-lists.html, which was updated on 15 Nov last year from the scipy-user move. I've already put in a new PR to be merged as soon as the move is completed: https://github.com/scipy/scipy.org/pull/200 Cheers, Ralf > and found myself wondering how comes that the last message is from > November last year. It took some time to realize that the last message > announces the migration to the new list... > Besides: "explicit is better than implicit" ... > Cheers, > Nenad > > _______________________________________________ > SciPy-User mailing list > SciPy-User at python.org > https://mail.python.org/mailman/listinfo/scipy-user > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From npropadovic at gmail.com Thu Mar 23 13:35:48 2017 From: npropadovic at gmail.com (Propadovic Nenad) Date: Thu, 23 Mar 2017 18:35:48 +0100 Subject: [SciPy-User] migration of all scipy.org Message-ID: Hello Ralf, thanks for the answer. Where did you find that outdated link, and does it still need fixing? Our > own page on that is https://scipy.org/scipylib/mailing-lists.html, which > was updated on 15 Nov last year from the scipy-user move. > Well I'm pretty sure I had seen that link somewhere at https://scipy.org/scipylib/mailing-lists.html , all right, and that was some time end of January or beginning of February. I do not see any incongruent links there any more. I had revisited the same page maybe two weeks later, and then found that one of the last posts (maybe the last post) in the archive announced the migration. Maybe I clicked an old link google gave me from its cache? I really don't know. Two things have not changed, however. The 'Read/Search'-links (pointing to gmane) for all lists give me blank pages. Might be more an issue of gmane (?), but still confusing for an unsuspecting new user. And the archive of scipy-svn has its last entries in May 2016, which I'd probably understand if I cared to think about it. Not sure I was able to help, cheers, Nenad -------------- next part -------------- An HTML attachment was scrubbed... URL: From ralf.gommers at gmail.com Fri Mar 24 06:48:38 2017 From: ralf.gommers at gmail.com (Ralf Gommers) Date: Fri, 24 Mar 2017 23:48:38 +1300 Subject: [SciPy-User] Is a worked paper example appropriate for documentation? In-Reply-To: <58CD93D3.7070007@gmail.com> References: <58CD93D3.7070007@gmail.com> Message-ID: On Sun, Mar 19, 2017 at 9:08 AM, Edward Richards wrote: > I am wondering if simple recipes for recreating paper figures are > appropriate for documentation, and if so, where should they be put? > > I have code to recreate figure 1 from E T Y Lee's paper "Choosing nodes in > parametric curve interpolation" (doi: 0010448589900031). I know very little > about interpolation, but I worked this example because of the response to > mathematica SE question # 10273. It seems to me like a good exploration of > some of the more esoteric features of interpolation, and it spans a number > of separate scipy.interpolate functions. > > Would adding code like this help or clutter existing documentation? > I'm not quite sure what to conclude from the plot, but with some more explanatory text it could be a useful. This kind of example would go in the tutorial section of the docs (here http://scipy.github.io/devdocs/tutorial/interpolate.html) > As a side note I feel that I am late to the party for missing by Docathon > a week. > Thanks for showing up - late is much better than never. On Python 2.7, your example will show a very cryptic error: Traceback (most recent call last): File "tmp13.py", line 17, in ax[0, 0].plot(*splev(us, splprep(p, u=np.arange(4) / 3, s=0)[0])) File "/home/rgommers/Code/scipy/scipy/interpolate/fitpack.py", line 151, in splprep quiet) File "/home/rgommers/Code/scipy/scipy/interpolate/_fitpack_impl.py", line 281, in splprep task, ipar, s, t, nest, wrk, iwrk, per) SystemError: error return without exception set This is due to integer division - you want to change your code so all arrays created with np.arange have float dtype. Also remove the ``block=False`` from the last line, that'll just lead to users confused about why their plot didn't show up. Cheers, Ralf > Thanks, > Ned > > import numpy as np > import matplotlib.pyplot as plt > from scipy.interpolate import splprep, splev, CubicSpline > > p = np.array([[0, 26, 28, 54], [0, 24, 24, 0]]) > dp = np.diff(p, axis=-1) > > def parametic_nodes(escale): > """Compute parametric knots location""" > t = np.hstack((0, np.cumsum(np.linalg.norm(dp, axis=0) ** escale))) > return t / np.max(t) > > us = np.arange(201) / 200 > > fig, ax = plt.subplots(2,2) > ax[0, 0].plot(*splev(us, splprep(p, u=np.arange(4) / 3, s=0)[0])) > ax[0, 0].plot(*splev(us, splprep(p, u=p[0, :] / 54, s=0)[0])) > ax[0, 0].plot(*splev(us, splprep(p, u=parametic_nodes(1), s=0)[0])) > > ax[0, 1].plot(*splev(us, splprep(p, u=parametic_nodes(0), s=0)[0])) > ax[0, 1].plot(*splev(us, splprep(p, u=parametic_nodes(0.5), s=0)[0])) > ax[0, 1].plot(*splev(us, splprep(p, u=parametic_nodes(1), s=0)[0])) > > ax[1, 0].plot(*splev(us, splprep(p, u=parametic_nodes(0.35), s=0)[0])) > ax[1, 0].plot(*splev(us, splprep(p, u=parametic_nodes(0.5), s=0)[0])) > ax[1, 0].plot(*splev(us, splprep(p, u=parametic_nodes(0.65), s=0)[0])) > > ax[1, 1].plot(*CubicSpline(np.arange(4) / 3, p.T, > bc_type='natural')(us).T) > ax[1, 1].plot(*CubicSpline(parametic_nodes(0.5), p.T, > bc_type='natural')(us).T) > ax[1, 1].plot(*CubicSpline(parametic_nodes(1), p.T, > bc_type='natural')(us).T) > > plt.show(block=False) > _______________________________________________ > SciPy-User mailing list > SciPy-User at python.org > https://mail.python.org/mailman/listinfo/scipy-user > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jni.soma at gmail.com Wed Mar 29 14:22:10 2017 From: jni.soma at gmail.com (Juan Nunez-Iglesias) Date: Wed, 29 Mar 2017 18:22:10 +0000 Subject: [SciPy-User] Announcement: scikit-image 0.13.0 Message-ID: We're happy to (finally) announce the release of scikit-image v0.13.0! Special thanks to our many contributors for making it possible! This release is the result of over a year of work, with over 200 pull requests by 82 contributors. Linux and macOS wheels are available now on PyPI , together with a source distribution. Use "pip install -U scikit-image" to get the latest version! Packages on conda-forge, Windows wheels, and Debian packages should be available within the next few days. scikit-image is an image processing toolbox for SciPy that includes algorithms for segmentation, geometric transformations, color space manipulation, analysis, filtering, morphology, feature detection, and more. For more information, examples, and documentation, please visit our website: http://scikit-image.org and our gallery of examples http://scikit-image.org/docs/dev/auto_examples/ Highlights ---------- - Improved n-dimensional image support. This release adds nD support to: * ``regionprops`` computation for centroids (#2083) * ``segmentation.clear_border`` (#2087) * Hessian matrix (#2194) - In addition, the following new functions support nD images: * new wavelet denoising function, ``restoration.denoise_wavelet`` (#1833, #2190, #2238, #2240, #2241, #2242, #2462) * new thresholding functions, ``filters.threshold_sauvola`` and ``filters.threshold_niblack`` (#2266, #2441) * new local maximum, local minimum, hmaxima, hminima functions (#2449) - Grey level co-occurrence matrix (GLCM) now works with uint16 images - ``filters.try_all_threshold`` to rapidly see output of various thresholding methods - Frangi and Hessian filters (2D only) (#2153) - New *compact watershed* algorithm in ``segmentation.watershed`` (#2211) - New *shape index* algorithm in ``feature.shape_index`` (#2312) New functions and features -------------------------- - Add threshold minimum algorithm (#2104) - Implement mean and triangle thresholding (#2126) - Add Frangi and Hessian filters (#2153) - add bbox_area to region properties (#2187) - colorconv: Add rgba2rgb() (#2181) - Lewiner marching cubes algorithm (#2052) - image inversion (#2199) - wavelet denoising (from #1833) (#2190) - routine to estimate the noise standard deviation from an image (#1837) - Add compact watershed and clean up existing watershed (#2211) - Added the missing 'grey2rgb' function. (#2316) - Shape index (#2312) - Fundamental and essential matrix 8-point algorithm (#1357) - Add YUV, YIQ, YPbPr, YCbCr colorspaces - Detection of local extrema from morphology (#2449) - shannon entropy (#2416) Documentation improvements -------------------------- - add details about github SSH keys in contributing page (#2073) - Add example for felzenszwalb image segmentation (#2096) - Sphinx gallery for example gallery (#2078) - Improved region boundary RAG docs (#2106) - Add gallery Lucy-Richardson deconvolution algorithm (#2376) - Gallery: Use Horse to illustrate Convex Hull (#2431) - Add working with OpenCV in user guide (#2519) Code improvements ----------------- - Remove lena image from test suite (#1985) - Remove duplicate mean calculation in skimage.feature.match_template (#1980) - Add nD support to clear_border (#2087) - Add uint16 images support for co-occurrence matrix (#2095) - Add default parameters for Gaussian and median filters (#2151) - try_all to choose the best threshold algorithm (#2110) - Add support for multichannel in Felzenszwalb segmentation (#2134) - Improved SimilarityTransform, new EuclideanTransform class (#2044) - ENH: Speed up Hessian matrix computation (#2194) - add n-dimensional support to denoise_wavelet (#2242) - Speedup ``inpaint_biharmonic`` (#2234) - Update hessian matrix code to include order kwarg (#2327) - Handle cases for label2rgb where input labels are negative and/or nonconsecutive (#2370) - Added watershed_line parameter (#2393) API Changes ----------- - Remove deprecated ``filter`` module. Use ``filters`` instead. (#2023) - Remove ``skimage.filters.canny`` links. Use ``feature.canny`` instead. (#2024) - Removed Python 2.6 support and related checks (#2033) - Remove deprecated {h/v}sobel, {h/v}prewitt, {h/v}scharr, roberts_{positive/negative} filters (#2159) - Remove deprecated ``_mode_deprecations`` (#2156) - Remove deprecated None defaults in ``rescale_intensity`` (#2161) - Parameters ``ntiles_x`` and ``ntiles_y`` have been removed from ``exposure.equalize_adapthist`` - The minimum NumPy version is now 1.11, and the minimum SciPy version is now 0.17 Deprecations ------------ - clip_negative will be set to false by default in version 0.15 (func: dtype_limits) (#2228) - Deprecate "dynamic_range" in favor of "data_range" (#2384) - The default value of the ``circle`` argument to ``radon`` and ``iradon`` transforms will be ``True`` in 0.15 (#2235) - The default value of ``multichannel`` for ``denoise_bilateral`` and ``denoise_nl_means`` will be ``False`` in 0.15 - The default value of ``block_norm`` in ``feature.hog`` will be L2-Hysteresis in 0.15. - The ``threshold_adaptive`` function is deprecated. Use ``threshold_local`` instead. - The default value of ``mode`` in ``transform.swirl``, ``resize``, and ``rescale`` will be "reflect" in 0.15. For a complete list of contributors and pull requests merged in this release, please see our release notes online: https://github.com/scikit-image/scikit-image/blob/master/doc/release/release_0.13.rst Please spread the word, including on Twitter ! Enjoy! Juan. -------------- next part -------------- An HTML attachment was scrubbed... URL: From jni.soma at gmail.com Wed Mar 29 13:44:19 2017 From: jni.soma at gmail.com (Juan Nunez-Iglesias) Date: Wed, 29 Mar 2017 13:44:19 -0400 Subject: [SciPy-User] Announcement: scikit-image 0.13.0 Message-ID: <5302d3ae-73b4-4458-a61f-b36a37d1792a@Spark> We're happy to (finally) announce the release of scikit-image v0.13.0! Special thanks to all our contributors who made this possible. Linux and macOS wheels are available now on PyPI, as well as a source distribution. A conda-forge package, Windows wheels, and Debian packages should arrive in the coming days. scikit-image is an image processing toolbox for SciPy that includes algorithms for segmentation, geometric transformations, color space manipulation, analysis, filtering, morphology, feature detection, and more. For more information, examples, and documentation, please visit our website: http://scikit-image.org and our gallery of examples http://scikit-image.org/docs/dev/auto_examples/ Highlights ---------- This release is the result of a year of work, with over 200 pull requests by 82 contributors. Highlights include: - Improved n-dimensional image support. This release adds nD support to: ? * ``regionprops`` computation for centroids (#2083) ? * ``segmentation.clear_border`` (#2087) ? * Hessian matrix (#2194, #2327) - In addition, the following new functions support nD images: ? * new wavelet denoising function, ``restoration.denoise_wavelet`` (#1833, #2190, #2238, #2240, #2241, #2242, #2462) ? * new thresholding functions, ``filters.threshold_sauvola`` and ``filters.threshold_niblack`` (#2266, #2441) ? * new local maximum, local minimum, hmaxima, hminima functions (#2449) - Grey level co-occurrence matrix (GLCM) now works with uint16 images - ``filters.try_all_threshold`` to rapidly see output of various thresholding methods - Frangi and Hessian filters (2D only) (#2153) - New *compact watershed* algorithm in ``segmentation.watershed`` (#2211) - New *shape index* algorithm in ``feature.shape_index`` (#2312) New functions and features -------------------------- - Add threshold minimum algorithm (#2104) - Implement mean and triangle thresholding (#2126) - Add Frangi and Hessian filters (#2153) - add bbox_area to region properties (#2187) - colorconv: Add rgba2rgb() (#2181) - Lewiner marching cubes algorithm (#2052) - image inversion (#2199) - wavelet denoising (from #1833) (#2190) - routine to estimate the noise standard deviation from an image (#1837) - Add compact watershed and clean up existing watershed (#2211) - Added the missing 'grey2rgb' function. (#2316) - Shape index (#2312) - Fundamental and essential matrix 8-point algorithm (#1357) - Add YUV, YIQ, YPbPr, YCbCr colorspaces - Detection of local extrema from morphology (#2449) - shannon entropy (#2416) Documentation improvements -------------------------- - add details about github SSH keys in contributing page (#2073) - Add example for felzenszwalb image segmentation (#2096) - Sphinx gallery for example gallery (#2078) - Improved region boundary RAG docs (#2106) - Add gallery Lucy-Richardson deconvolution algorithm (#2376) - Gallery: Use Horse to illustrate Convex Hull (#2431) - Add working with OpenCV in user guide (#2519) Code improvements ----------------- - Remove lena image from test suite (#1985) - Remove duplicate mean calculation in skimage.feature.match_template (#1980) - Add nD support to clear_border (#2087) - Add uint16 images support for co-occurrence matrix (#2095) - Add default parameters for Gaussian and median filters (#2151) - try_all to choose the best threshold algorithm (#2110) - Add support for multichannel in Felzenszwalb segmentation (#2134) - Improved SimilarityTransform, new EuclideanTransform class (#2044) - ENH: Speed up Hessian matrix computation (#2194) - add n-dimensional support to denoise_wavelet (#2242) - Speedup ``inpaint_biharmonic`` (#2234) - Update hessian matrix code to include order kwarg (#2327) - Handle cases for label2rgb where input labels are negative and/or ? nonconsecutive (#2370) - Added watershed_line parameter (#2393) API Changes ----------- - Remove deprecated ``filter`` module. Use ``filters`` instead. (#2023) - Remove ``skimage.filters.canny`` links. Use ``feature.canny`` instead. (#2024) - Removed Python 2.6 support and related checks (#2033) - Remove deprecated {h/v}sobel, {h/v}prewitt, {h/v}scharr, roberts_{positive/negative} filters (#2159) - Remove deprecated ``_mode_deprecations`` (#2156) - Remove deprecated None defaults in ``rescale_intensity`` (#2161) - Parameters ``ntiles_x`` and ``ntiles_y`` have been removed from ``exposure.equalize_adapthist`` - The minimum NumPy version is now 1.11, and the minimum SciPy version is now 0.17 Deprecations ------------ - clip_negative will be set to false by default in version 0.15 ? (func: dtype_limits) (#2228) - Deprecate "dynamic_range" in favor of "data_range" (#2384) - The default value of the ``circle`` argument to ``radon`` and ``iradon`` transforms will be ``True`` in 0.15 (#2235) - The default value of ``multichannel`` for ``denoise_bilateral`` and ``denoise_nl_means`` will be ``False`` in 0.15 - The default value of ``block_norm`` in ``feature.hog`` will be L2-Hysteresis in 0.15. - The ``threshold_adaptive`` function is deprecated. Use ``threshold_local`` instead. - The default value of ``mode`` in ``transform.swirl``, ``resize``, and ``rescale`` will be "reflect" in 0.15. For a complete list of contributors to this release, and PRs merged, please see the online release notes: https://github.com/scikit-image/scikit-image/blob/master/doc/release/release_0.13.rst Enjoy! -------------- next part -------------- An HTML attachment was scrubbed... URL: