SciPy

Topical software

This page indexes add-on software and other resources relevant to SciPy, categorized by scientific discipline or computational topic. It is intended to be exhaustive. If you know of an unlisted resource, see About this page, below.

Additional useful software packages can be found on the Python Package Index, especially in its Science/Research category.

You may also want to take a look at the list of SciKits, Python packages oriented specifically at scientific computation tasks.

About this page

The listings are roughly organized by topic, with introductory resources first, more general topics next, and discipline-specific resources last.

Unless otherwise indicated, all packages listed here are provided under some form of an open-source license.

If you distribute or know of a resource that is not listed here, please add a listing. You can do this by creating an account on GitHub and going to the source of this page. There, click the “Edit” button and make the changes. Alternatively, send mail to scipy-dev mailing list with subject “Addition to topical software page”.

Please include a description — be as brief as you can, but make sure you include in your text a link to the resource’s home page and some keywords that potential users might search for to find the resource.

If you wish to restructure the page (e.g., break out a section into its own page, change the section headings, etc.), please propose the idea to the SciPy-dev@scipy.org mailing list first and get community feedback.

General Python resources

Tutorials and texts

Generic Python/programming tutorials:

Scientific computing with Python tutorials:

Older scientific computing tutorials:

Working environments

  • Anaconda: a free, enterprise-ready Python distribution with hundreds of cross-platform-tested and optimized packages for Mac OS X, Windows, and Linux users. Installs into a single directory. Doesn’t require root or local administrator privileges. Contains the package and environment manager tool, conda <http://conda.pydata.org/>.

  • Python(x,y): a complete distribution for Windows or Ubuntu users containing all the packages needed for full Python distribution for scientific development, including Qt based GUI design. Also includes Spyder (see below), a Python IDE suited to scientific development. Python 2 only.

  • WinPython: similar to Python(x, y), another comprehensive distribution including scientific packages and the Spyder IDE. Windows only, but more actively maintained and supports the latest Python 3 releases.

  • IPython: an interactive environment with many features geared towards efficient work in typical scientific usage. It borrows many ideas from the interactive shells of Mathematica, IDL, MATLAB and similar packages. It includes special support for the matplotlib and gnuplot plotting packages. IPython also has support for (X)Emacs, to be used as a full IDE with IPython as the interactive Python shell.

  • Jupyter Notebook: a web application that works off of the IPython and allows you to create and share documents containing live code and can be used in all sorts of contexts from statistical modeling to data cleaning.

  • Spyder: a PyQt-based IDE combining the editing, analysis, debugging and profiling functionality of a software development tool with the data exploration, interactive execution, deep inspection, and rich visualization capabilities of a scientific environment. Includes integrated IPython, SymPy, PyLab, and Cython consoles, a variable explorer with support for GUI editing and manipulation of collections, NumPy arrays, pandas DataFrames and arbitrary objects, a SciPy-based data import wizard, and built-in Matplotlib visualization.

  • Microsoft Visual Studio: a free, rich IDE that natively supports Python and Anaconda. It also supports CPython, IronPython, the IPython REPL, debugging, profiling, Git and GitHub. Also has a lighter version, named Visual Studio Code, which is a code editor with debugger. Both feature powerful IntelliSense, and support Windows and macOS, plus Linux, in the case of Code.

  • Enthought Canopy: an analysis environment that includes Enthought’s Python distribution and an analysis desktop with a code-checking text editor and an IPython console. Canopy also includes a graphical package manager, online documentation browser and support for Linux, Windows, and Mac.

  • IEP: a cross-platform Python IDE focused on interactivity and introspection, which makes it very suitable for scientific computing. Its practical design is aimed at simplicity and efficiency. IEP consists of two main components, the editor and the shell, and uses a set of pluggable tools to help the programmer in various ways. Some example tools are source structure, project manager, interactive help, workspace, etc.

  • Pymacs: a tool which, once started from Emacs, allows both-way communication between Emacs Lisp and Python.

  • Python Tools for Visual Studio: a rich IDE plugin for Visual Studio that supports CPython, IronPython, the IPython REPL, debugging, profiling, including running debugging MPI program on HPC clusters.

  • Plotly: an online Python environment for data exploration and graphing. Plotly has a command line, and allows for storage and sharing of Python scripts, and has special support for interactive Plotly graphs.

  • Other IDE links: the official Python website maintains a comprehensive lists of IDEs for Python.

Science: basic tools

These are links which cover basic tools generally useful for scientific work in almost any area. Many of the more specific packages listed later depend on one or more of these.

  • SciPy: umbrella project which includes a variety of high level science and engineering modules together as a single package. SciPy includes modules for linear algebra (including wrappers to BLAS and LAPACK), optimization, integration, special functions, FFTs, signal and image processing, ODE solvers, and others.

  • NumPy: the package SciPy builds on and requires as a pre-requisite. It is a hybrid of both Numeric and Numarray incorporating features of both. If you are new to Numeric computing with Python, you should use NumPy.

  • ScientificPython : another collection of Python modules for scientific computing. It includes basic geometry (vectors, tensors, transformations, vector and tensor fields), quaternions, automatic derivatives, (linear) interpolation, polynomials, elementary statistics, nonlinear least-squares fits, unit calculations, FORTRAN-compatible text formatting, 3D visualization via VRML, and two Tk widgets for simple line plots and 3D wireframe models. There are also interfaces to the netCDF library (portable structured binary files), to MPI (Message Passing Interface, message-based parallel programming), and to BSPlib (Bulk Synchronous Parallel programming). Much of this functionality has been incorporated into SciPy, but not all.

  • Numexpr: a package that accepts numpy array expressions as strings, rewrites them to optimize execution time and memory use, and executes them much faster than numpy usually can.

  • PyGSL: a Python interface for the GNU scientific library (gsl).

  • GMPY2: a Python interface for the GNU Multiple Precision library (gmp).

  • PyROOT: a runtime-based Python binding to the ROOT framework: ROOT is a complete system for development of scientific applications, from math and graphics libraries, to efficient storage and reading of huge data sets, to distributed analysis. The Python bindings are based on runtime-type information, such that you can add your own C++ classes on the fly to the system with a one-liner and down-casting as well as pointer manipulations become unnecessary. Using RTTI keeps memory and call overhead down to a minimum, resulting in bindings that are more lightweight and faster than any of the “standard” bindings generators.

  • bvp: a Python wrapper for a modified version of the COLNEW boundary value problem solver. (COLNEW has a non-commercial-only type license)

  • NetworkX: a Python package for the creation, manipulation, and study of the structure, dynamics, and function of complex networks.

  • PyAMG: a library of Algebraic Multigrid (AMG) solvers for large scale linear algebra problems.

  • PyTrilinos: a Python interface to Trilinos, a framework for solving large-scale, complex multi-physics engineering and scientific problems.

  • PyIMSLStudio: a complete packaged, supported and documented development environment for Windows and Red Hat designed for prototyping mathematics and statistics models and deploying them into production applications. PyIMSL Studio includes wrappers for the IMSL Numerical Library, a Python distribution and a selection of open source Python modules useful for prototype analytical development. PyIMSL Studio is available for download at no charge for non-commercial use or for commercial evaluation.

  • Bottleneck: a collection of fast NumPy array functions written in Cython.

  • KryPy: a Krylov subspace methods package for the efficient solution of linear algebraic systems with large and sparse matrices.

  • Imageio: a library that provides an easy interface to read and write a wide range of image data, including animated images, video, volumetric data, and scientific formats. It is cross-platform, runs on Python 2.x and 3.x, and is easy to install.

  • mpmath: a free (BSD-licensed) Python library for real and complex floating-point arithmetic with arbitrary precision.

  • paramnormal: a wrapper around the scipy.stats module that facilitates creating, fitting, and vizualizing probability distributions with more conventional parameters.

  • MetroloPy: tools for dealing with physical quantities: uncertainty propagation and unit conversion

Running code written in other languages

Wrapping C, C++, and FORTRAN code

  • SWIG: SWIG is a software development tool that connects programs written in C and C++ with a variety of high-level programming languages. SWIG is primarily used with common scripting languages, such as Perl, Python, Tcl/Tk, and Ruby.

  • Boost.Python: a C++ library which enables seamless interoperability between C++ and Python. The PythonInfo Wiki contains a good howto reference. “c++-sig”: https://www.python.org/community/sigs/current/cplusplus-sig/ at python.org is devoted to Boost and you can subscribe to their mailing list.

  • F2PY: provides a connection between the Python and FORTRAN languages. F2PY is a Python extension tool for creating Python C/API modules from (handwritten or F2PY generated) signature files (or directly from FORTRAN sources).

  • Cython: allows the inclusion of C/C++ within Python code. It has facilities for automatic creation of C/C++ based Python extension modules, as well as for direct inlining of C/C++ code in Python sources. The latter combines the scripting flexibility of Python with the execution speed of compiled C/C++, while handling automatically all module generation details.

  • Pyrex: Pyrex lets you write code that mixes Python and C data types any way you want, and compiles it into a C extension for Python. See also Cython.

  • PyCxx: CXX/Objects is a set of C++ facilities to make it easier to write Python extensions. The chief way in which PyCXX makes it easier to write Python extensions is that it greatly increases the probability that your program will not make a reference-counting error and will not have to continually check error returns from the Python C API.

  • ctypes: a package to create and manipulate C data types in Python, and to call functions in dynamic link libraries/shared dlls. It allows wrapping these libraries in pure Python.

  • railgun: ctypes utilities for faster and easier simulation programming in C and Python

Wrapping MATLAB, R, and IDL codes

  • matlab: the “official” Python interface to MATLAB. Interfaces with MATLAB by treating it as a computational engine. For information about how to interface with Python from MATLAB, visit this link here.

  • pythoncall: a MATLAB-to-Python bridge. Runs a Python interpreter inside MATLAB and allows transferring data (matrices etc.) between the Python and MATLAB workspaces.

  • rpy2: a very simple, yet robust, Python interface to the R Programming Language. It can manage all kinds of R objects and can execute arbitrary R functions (including the graphic functions). All errors from the R language are converted to Python exceptions. Any module installed for the R system can be used from within Python.

  • mirpyidl: a library to call IDL (Interactive Data Language) from Python. Allows transparent wrapping of IDL routines and objects as well as arbitrary execution of IDL code. Utilizes connections to a separately running idlrpc server (distributed with IDL).

Converting code from other array languages

  • IDL: the Interactive Data Language from ITT

  • SMOP: a small MATLAB and Octave to Python converter. Translates legacy MATLAB libraries to python.

Plotting, data visualization, 3-D programming

Tools with a (mostly) 2-D focus

  • matplotlib: a Python 2-D plotting library, which produces publication-quality figures used in a variety of hardcopy formats (PNG, JPG, PS, SVG) and interactive GUI environments (WX, GTK, Tkinter, FLTK, Qt) across platforms. matplotlib can be used in Python scripts, interactively from the Python shell (à la MATLAB or Mathematica), in web application servers generating dynamic charts, or embedded in GUI applications. For interactive use, IPython provides a special mode which integrates with matplotlib. See the matplotlib gallery for recipes.

  • Bokeh: an interactive web visualization library for large datasets. Its goal is to provide elegant, concise construction of novel graphics in the style of Protovis/D3, while delivering high-performance interactivity over large data to thin clients.

  • Chaco: Chaco is a Python toolkit for producing interactive plotting applications. Chaco applications can range from simple line plotting scripts up to GUI applications for interactively exploring different aspects of interrelated data. As an open-source project being developed by Enthought, Chaco leverages other Enthought technologies, such as Kiva, Enable, and Traits to produce highly interactive plots of publication quality.

  • PyQwt: a set of Python bindings for the Qwt C++ class library which extends the Qt framework with widgets for scientific and engineering applications. It provides a widget to plot 2-D data and various widgets to display and control bounded or unbounded floating point values.

  • HippoDraw: a highly interactive data analysis environment. It is written in C++ with the Qt library from The Qt Company. It includes Python bindings, and has a number of features for the kinds of data analysis typical of High Energy physics environments, as it includes native support for ROOT NTuples. It is well optimized for real-time data collection and display.

  • Biggles: a module for creating publication-quality 2-D scientific plots. It supports multiple output formats (postscript, x11, png, svg, gif), understands simple TeX, and sports a high-level, elegant interface.

  • Gnuplot.py: a Python package that interfaces to gnuplot, the popular open-source plotting program. It allows you to use gnuplot from within Python to plot arrays of data from memory, data files, or mathematical functions. If you use Python to perform computations or as “glue” for numerical programs, you can use this package to plot data on the fly as they are computed. IPython includes additional enhancements to Gnuplot.py (but which require the base package) to make it more efficient in interactive usage.

  • Graceplot: a Python interface to the Grace 2-D plotting program.

  • disipyl: an object-oriented wrapper around the DISLIN plotting library, written in the computer language Python. disipyl provides a set of classes which represent various aspects of DISLIN plots, as well as providing some easy to use classes for creating commonly used plot formats (e.g. scatter plots, histograms, 3-D surface plots). A major goal in designing the library was to facilitate interactive data exploration and plot creation.

  • OpenCV: mature library for image processing, structural analysis, motion analysis and object tracking, and pattern recognition that has recently added Swig-based Python bindings. Windows and Linux-RPM packages available. An open-source project originally sponsored by Intel, can be coupled with Intel Performance Primitive package (IPP) for increased performance.

  • pygame: though intended for writing games using Python, its general-purpose multimedia libraries definitely have other applications in visualization.

  • PyNGL: a Python module for creating publication-quality 2-D visualizations, with emphasis on geosciences. PyNGL can create contours, vectors, streamlines, XY plots, and overlay any one of these on several map projections. PyNGL’s graphics are based on the same high-quality graphics as the NCAR Command Language and NCAR Graphics.

  • Veusz : a scientific plotting package written in Python. It uses PyQt and NumPy. Veusz is designed to produce publication-ready PDF, SVG, bitmap, and Postscript output.

  • Yellowbrick A suite of custom matplotlib visualizers for scikit-learn estimators to support visual model selection, evaluation, and diagnostics.

Data visualization (mostly 3-D, surfaces and volumetric rendering)

  • Mayavi2: a free, easy-to-use scientific data visualizer in Python. It uses the amazing Visualization Toolkit (VTK) for the graphics and provides a GUI written using Tkinter. MayaVi supports visualizations of scalar, vector, and tensor data in a variety of ways, including meshes, surfaces, and volumetric rendering. MayaVi can be used both as a standalone GUI program and as a Python library to be driven by other Python programs. It supports NumPy arrays transparently and provides a powerful pylab like equivalent called mlab for rapid 3-D plotting.

  • visvis: a pure Python library for visualization of 1-D to 4-D data in an object-oriented way. Essentially, visvis is an object-oriented layer of Python on top of OpenGl, thereby combining the power of OpenGl with the usability of Python. A MATLAB-like interface in the form of a set of functions allows easy creation of objects (e.g., plot(), imshow(), volshow(), surf()).

  • S2PLOT: a 3-D plotting library based on OpenGL with support for standard and enhanced display devices. The S2PLOT library was written in C and can be used with C, C++, FORTRAN, and Python programs on GNU/Linux, Apple/OSX, and GNU/Cygwin systems. The library is currently closed-source, but free for commercial and academic use. They are hoping for an open-source release towards the end of 2008.

LaTeX, PostScript, diagram generation

  • PyX: a package for the creation of encapsulated PostScript figures. It provides both an abstraction of PostScript and a TeX/LaTeX interface. Complex tasks like 2-D and 3-D plots in publication-ready quality are built out of these primitives.

  • Dot2TeX: Another tool in the Dot/Graphviz/LaTeX family, this is a Graphviz to LaTeX converter. The purpose of dot2tex is to give graphs generated by Graphviz a more LaTeX friendly look and feel. This is accomplished by converting xdot output from Graphviz to a series of PSTricks or PGF/TikZ commands.

  • pyreport: runs a script and captures the output (pylab graphics included). Generates a LaTeX or pdf report out of it, including literal comments and pretty printed code.

Other 3-D programming tools

  • VPython: a Python module that offers real-time 3-D output, and is easily usable by novice programmers.

  • OpenRM Scene Graph:: a developers toolkit that implements a scene graph API, and which uses OpenGL for hardware accelerated rendering. OpenRM is intended to be used to construct high performance, portable graphics and scientific visualization applications on Unix/Linux/Windows platforms.

  • Panda3D: an open-source game and simulation engine.

  • Python Computer Graphics Kit:: a collection of Python modules that contain the basic types and functions required for creating 3-D computer graphics images.

  • Python 3-D software collection: a small collection of pointers to Python software for working in three dimensions.

  • pythonOCC: Python bindings for OpenCascade, a 3-D modeling and numerical simulation library. (related projects)

  • PyGTS: a Python package used to construct, manipulate, and perform computations on 3-D triangulated surfaces. It is a hand-crafted and pythonic binding for the GNU Triangulated Surface (GTS) Library.

  • pyFormex: a program for generating, transforming, and manipulating large geometrical models of 3-D structures by sequences of mathematical operations.

Any-dimensional tools

  • SpaceFuncs: a tool for 2-D, 3-D, N-D geometric modeling with possibilities of parametrized calculations, numerical optimization, and solving systems of geometrical equations with automatic differentiation.

  • pyqtgraph: pure Python plotting, 3-D graphics (including volumetric and isosurface rendering), and GUI library based on PyQt, python-opengl, and NumPy/SciPy. Includes tools for display and manipulation of multidimensional image data. Intended for use in scientific/engineering applications; fast enough for realtime data/video display.

Optimization

  • CMA: Covariance Matrix Adaptation Evolution Strategy for non-linear numerical optimization in Python.

  • CVXOPT: (license: GPL3), a tool for convex optimization, which defines its own matrix-like object and interfaces to FFTW, BLAS, and LAPACK.

  • CVXPY: a Python-embedded modeling language for convex optimization problems.

  • DEAP: Distributed Evolutionary Algorithms in Python.

  • ECsPy: Evolutionary Computations in Python.

  • Mystic: an optimization framework focused on continuous optimization.

  • NLPy: a Python optimization framework that leverages AMPL to create problem instances, which can then be processed in Python.

  • OpenOpt: (license: BSD), a numerical optimization framework with some own solvers and connections to lots of other. It allows connection of ‘’’any’’’-licensed software, while scipy.optimize allows only a copyleft-free one (like BSD, MIT). Other features are convenient standard interface for all solvers, graphical output, categorical variables, disjunctive and other logical constraints, automatic 1st derivatives check, multi-factor analysis tool for experiment planning, and much more. You can optimize FuncDesigner models with automatic differentiation. OpenOpt also has a commercial add-on (free for small-scale research/educational problems) for stochastic programming.

  • PuLP: a Python package that can be used to describe linear programming and mixed-integer linear programming optimization problems.

  • PyEvolve: Genetic Algorithms in Python.

  • Pyiopt: a Python interface to the COIN-OR Ipopt solver.

  • Pyomo: Pyomo is a collection of Python optimization-related packages that supports a diverse set of optimization capabilities for formulating and analyzing optimization models.

  • python-zibopt: a Python interface to SCIP.

  • scikits.optimization: a generic optimization framework entirely written in Python.

  • lmfit-py: a wrapper around scipy.optimize.leastsq that uses named fitting parameters, which may be varied, fixed, or constrained with simple mathematical expressions.

  • noisyopt: provides algorithms for the optimization of noisy functions including pattern search with adaptive sampling and simultaneous perturbation stochastic approximation.

  • scipydirect: a wrapper about the DIRECT algorithm for global optimization.

Systems of nonlinear equations

  • fsolve from scipy.optimize.

  • sympy and its solvers module, which can be used to solve both linear and nonlinear equations.

Automatic differentiation

(not to be confused with numerical differentiation via finite-differences derivatives approximation and symbolic differentiation provided by Maxima, SymPy etc., see wikipedia.org entry)

  • FuncDesigner: also can solve ODE and use OpenOpt for numerical optimization, perform uncertainty and interval analysis.

  • ScientificPython: see modules Scientific.Functions.FirstDerivatives and Scientific.Functions.Derivatives.

  • pycppad: a wrapper for CppAD, second order forward/reverse.

  • pyadolc: a wrapper for ADOL-C, arbitrary order forward/reverse.

  • algopy: evaluation of higher-order derivatives in the forward and reverse mode of algorithmic differentiation, with a particular focus on numerical linear algebra.

  • CasADi: a symbolic framework for algorithmic (a.k.a. automatic) differentiation and numeric optimization.

  • autograd: efficient automatic differentiation with good support for code using NumPy.

Finite differences derivatives approximation

  • check_grad: from scipy.optimize.

  • DerApproximator: several stencils, trying to avoid NaNs, is used by FuncDesigner.

  • numdifftools: tools to solve numerical differentiation problems in one or more variables, based on extrapolation of finite differences.

Data storage / database

  • PyTables: PyTables is a hierarchical database package designed to efficiently manage very large amounts of data. It is built on top of the HDF5 library and the NumPy package.

  • python-hdf4: python-hdf4 is a Python interface to the HDF4 library. Among the numerous components offered by HDF4, the following are currently supported by pyhdf: SD (Scientific Dataset), VS (Vdata), V (Vgroup), and HDF (common declarations).

  • h5py: h5py is a Python interface to the HDF5 library. It provides a more direct wrapper for HDF5 than PyTables.

Parallel and distributed programming

For a brief discussion of parallel programming within NumPy/SciPy, see Parallel Programming.

  • PyMPI: distributed parallel programming for Python. This package builds on traditional Python by enabling users to write distributed, parallel programs based on MPI message passing primitives. General Python objects can be messaged between processors.

  • Pypar: parallel programming in the spirit of Python Pypar is an efficient but easy-to-use module that allows programs/scripts written in the Python programming language to run in parallel on multiple processors and communicate using message passing. Pypar provides bindings to an important subset of the message passing interface standard MPI.

  • Joblib: a tool set for lightweight pipelining in Python for easy parallel computing.

  • jug: a task-based parallel framework. It is especially useful for embarrassingly parallel problems such as parameter sweeps. It can take advantage of a multi-core machine or a set of machines on a computing cluster.

  • MPI for Python: object-oriented Python bindings for the Message Passing Interface. This module provides MPI support to run Python scripts in parallel. It is constructed on top of the MPI-1 specification, but provides an object-oriented interface, which closely follows standard MPI-2 C++ bindings. Any ‘’picklable’’ Python object can be communicated. There is support for point-to-point (sends, receives) and collective (broadcasts, scatters, gathers) communications as well as group and communicator (inter, intra, and topologies) management.

  • Module Scientific: BSP in Konrad Hinsen’s ScientificPython provides an experimental interface to the Bulk Synchronous Parallel (BSP) model of parallel programming (note the link to the BSP tutorial on the ScientificPython page). Module Scientific.MPI provides an MPI interface. The BSP model is an alternative to MPI and PVM message passing model. It is said to be easier to use than the message passing model, and is guaranteed to be deadlock-free.

  • Pyro: Python Remote Objects (Pyro) provides an object-oriented form of RPC. It is a Distributed Object Technology system written entirely in Python, designed to be very easy to use. Never worry about writing network communication code again, when using Pyro you just write your Python objects like you would normally. With only a few lines of extra code, Pyro takes care of the network communication between your objects once you split them over different machines on the network. All the gory socket programming details are taken care of, you just call a method on a remote object as if it were a local object.

  • PyXG: object-oriented Python interface to Apple’s Xgrid. PyXG makes it possible to submit and manage Xgrid jobs and tasks from within interactive Python sessions or standalone scripts. It provides an extremely lightweight method for performing independent parallel tasks on a cluster of Macintosh computers.

  • Pyslice: Pyslice is a specialized templating system that replaces variables in a template data set with numbers taken from all combinations of variables. It creates a dataset from input template files for each combination of variables in the series and can optionally run a simulation or submit a simulation run to a queue against each created data set. For example: create all possible combination of datasets that represent the ‘flow’ variable with numbers from 10 to 20 by 2 and the ‘level’ variable with 24 values taken from a normal distribution with a mean of 104 and standard deviation of 5.

  • PyOpenCL: OpenCL is a standard for parallel programming on heterogeneous devices including CPUs, GPUs, and other processors. It provides a common C-like language for executing code on those devices, as well as APIs to setup the computations. PyOpenCL aims at being an easy-to-use Python wrapper around the OpenCL library.

  • PyCUDA: PyCUDA is a Python interface to Nvidia’s CUDA parallel computation API. This library can be used safely within a multi-processor or multi-thread environment.

  • PyCSP: Communicating Sequential Processes for Python. PyCSP may be used to structure scientific software into concurrent tasks. Dependencies are handled through explicit communication and allow for better understanding of the structure. A PyCSP application can be executed using co-routines, threads, or processes.

Partial differential equation (PDE) solvers

  • FiPy: see entry in ‘’’Miscellaneous’’’.

  • SfePy: see entry in ‘’’Miscellaneous’’’.

  • Hermes: hp-FEM solver, see entry in ‘’’Miscellaneous’’’.

Topic guides, organized by scientific field

Astronomy

  • AstroPy: central repository of information about Python and Astronomy.

  • AstroPython: knowledge base for research in astronomy using Python.

  • Astropy and its fits package: interface to FITS formatted files under the Python scripting language and PyRAF, the Python-based interface to IRAF.

  • PyRAF: a new command language for running IRAF tasks that is based on the Python scripting language.

  • BOTEC: a simple astrophysical and orbital mechanics calculator, including a database of all named Solar System objects.

  • AstroLib: an open-source effort to develop general astronomical utilities akin to those available in the IDL ASTRON package.

  • APLpy: a Python module aimed at producing publication-quality plots of astronomical imaging data in FITS format.

  • Tutorial: using Python for interactive data analysis in astronomy.

  • Casa: a suite of C++ application libraries for the reduction and analysis of radioastronomical data (derived from the former AIPS++ package) with a Python scripting interface.

  • Healpy: Python package for using and plotting HEALpix data (e.g., spherical surface maps such as WMAP data).

  • Pysolar: Collection of Python libraries for simulating the irradiation of any point on earth by the sun. Pysolar includes code for extremely precise ephemeris calculations, and more. Could be also grouped under engineering tools.

  • pywcsgrid2: display astronomical fits images with matplotlib.

  • pyregion: Python module to parse ds9 region files (also supports ciao regions files).

  • SpacePy: provides tools for the exploration and analysis of data in the space sciences. Features include a Pythonic interface to NASA CDF, time and coordinate conversions, a datamodel for manipulation of data and metadata, empirical models widely used in space science, and tools for everything from statistical analysis to multithreading.

Artificial intelligence and machine learning

  • See also the ‘’’Bayesian Statistics’’’ section below.

  • scikit learn: general-purpose efficient machine learning and data mining library in Python for SciPy.

  • ffnet: feed-forward neural network for Python, uses NumPy arrays and SciPy optimizers.

  • pyem: a tool for Gaussian Mixture Models. It implements the EM algorithm for Gaussian mixtures (including full matrix covariances) and the BIC criterion for clustering. It is included in the scikit-learn toolbox.

  • PyBrain: machine learning library with focus on reinforcement learning, (recurrent) neural networks and black-box optimization.

  • Orange: component-based data mining software.

  • pymorph Morphology Toolbox: the pymorph Morphology Toolbox for Python is a powerful collection of the latest state-of-the-art gray-scale morphological tools that can be applied to image segmentation, non-linear filtering, pattern recognition, and image analysis. Pymorph was originally written by Roberto A. Lutofu and Rubens C. Machado but is now maintained by Luis Pedro Coelho.

  • pycplex: a Python interface to the ILOG CPLEX Callable Library.

  • ELEFANT: we aim at developing an open-source machine learning platform which will become the platform of choice for prototyping and deploying machine learning algorithms.

  • Bayes Blocks: the library is a C++/Python implementation of the variational building block framework using variational Bayesian learning.

  • Monte Python: a machine learning library written in pure Python. The focus is on gradient-based learning. Monte includes neural networks, conditional random fields, logistic regression, and more.

  • hcluster: a hierarchical clustering library for SciPy with base implementation written in C for efficiency. Clusters data, computes cluster statistics, and plots dendrograms.

  • PyPR: a collection of machine learning methods written in Python: Artificial Neural Networks, Gaussian Processes, Gaussian mixture models, and K-means.

  • Theano: A CPU and GPU Math Expression Compiler, Theano is a Python library that allows you to define, optimize, and evaluate mathematical expressions involving multi-dimensional arrays efficiently.

  • NeuroLab: Neurolab is a simple and powerful neural networks library for Python.

  • scikit network: Python library for the analysis of large graphs, represented as sparse matrices in the CSR format of SciPy.

Bayesian statistics

  • PyMC2: PyMC2 is a Python module that provides a Markov Chain Monte Carlo (MCMC) toolkit, making Bayesian simulation models relatively easy to implement. PyMC relieves users of the need for re-implementing MCMC algorithms and associated utilities, such as plotting and statistical summary. This allows the modelers to concentrate on important aspects of the problem at hand, rather than on the mundane details of Bayesian statistical simulation.

  • PyBayes: PyBayes is an object-oriented Python library for recursive Bayesian estimation (Bayesian filtering) that is convenient to use. Already implemented are Kalman filter, particle filter and marginalized particle filter, all built atop of a light framework of probability density functions. PyBayes can optionally use Cython for large speed gains (Cython build is several times faster).

  • NIFTY: Numerical Information Field Theory offers a toolkit designed to enable the coding of signal inference algorithms that operate regardless of the underlying spatial grid and its resolution.

Biology (including neuroscience)

  • Brian: a simulator for spiking neural networks in Python.

  • BioPython: an international association of developers of freely available Python tools for computational molecular biology.

  • PyCogent: a software library for genomic biology.

  • Python For Structural BioInformatics Tutorial: this tutorial demonstrates the utility of the interpreted programming language Python for the rapid development of component-based applications for structural bioinformatics. We introduce the language itself, along with some of its most important extension modules. Bio-informatics specific extensions will also be described and we demonstrate how these components have been assembled to create custom applications.

  • PySAT: Python Sequence Analysis Tools (Version 1.0): PySAT is a collection of bioinformatics tools written entirely in Python. A paper describing these tools.

  • PySCeS: the Python Simulator for Cellular Systems: PySCes includes tools for the simulation and analysis of cellular systems (GPL).

  • SloppyCell: SloppyCell is a software environment for simulation and analysis of biomolecular networks developed by the groups of Jim Sethna and Chris Myers at Cornell University.

  • PyDSTool: PyDSTool is an integrated simulation, modeling, and analysis package for dynamical systems used in scientific computing, and includes special toolboxes for computational neuroscience, biomechanics, and systems biology applications.

  • NIPY: the neuroimaging in Python project is an environment for the analysis of structural and functional neuroimaging data. It currently has a full system for general linear modeling of functional magnetic resonance imaging (FMRI).

  • ACQ4: data acquisition and analysis system for electrophysiology, photostimulation, and fluorescence imaging.

  • Vision Egg: produce stimuli for vision research experiments.

  • PsychoPy: create psychology stimuli in Python.

  • pyQPCR: a GUI application that allows to compute quantitative PCR (QPCR) raw data. Using quantification cycle values extracted from QPCR instruments, it uses a proven and universally applicable model (Delta-delta ct method) to give finalized quantification results.

  • VeSPA: the VeSPA suite contains three magnetic resonance (MR) spectroscopy applications: RFPulse (for RF pulse design), Simulation (for spectral simulation), and Analysis (for spectral data processing and analysis).

  • Neo: a package for representing electrophysiology data in Python, together with support for reading a wide range of neurophysiology file formats.

  • Myokit: a programming toolkit for working with ODE models of cardiac myocytes (and other excitable tissues).

  • MNE-Python: a package for magnetoencephalography (MEG) and electroencephalography (EEG) data analysis.

Dynamical systems

  • PyDSTool: PyDSTool is an integrated simulation, modeling, and analysis package for dynamical systems (ODEs, DDEs, DAEs, maps, time-series, hybrid systems). Continuation and bifurcation analysis tools are built-in, via PyCont. It also contains a library of general classes useful for scientific computing, including an enhanced array class and wrappers for SciPy algorithms. Application-specific utilities are also provided for systems biology, computational neuroscience, and biomechanics. Development of complex systems models is simplified using symbolic math capabilities and compositional model-building classes. These can be “compiled” automatically into dynamically-linked C code or Python simulators.

  • SimPy: SimPy (= Simulation in Python) is an object-oriented, process-based discrete-event simulation language based on standard Python. It is released under the GNU Lesser GPL (LGPL). SimPy provides the modeler with components of a simulation model including processes, for active components like customers, messages, vehicles, and resources, for passive components that form limited capacity congestion points like servers, checkout counters, and tunnels. It also provides monitor variables to aid in gathering statistics. Random variates are provided by the standard Python random module. SimPy comes with data collection capabilities, GUI, and plotting packages. It can be easily interfaced to other packages, such as plotting, statistics, GUI, spreadsheets, and databases.

  • Model-Builder: Model-Builder is a GUI-based application for building and simulation of ODE (Ordinary Differential Equations) models. Models are defined in mathematical notation, with no coding required from the user. Results can be exported in csv format. Graphical output based on matplotlib includes time-series plots, state-space plots, spectrograms, and continuous wavelet transforms of time series. It also includes a sensitivity and uncertainty analysis module. Ideal for classroom use.

  • VFGEN: VFGEN is a source code generator for differential equations and delay differential equations. The equations are defined once in an XML format, and then VFGEN is used to generate the functions that implement the equations in a wide variety of formats. Python users will be interested in the SciPy, PyGSL, and PyDSTool commands provided by VFGEN.

  • DAE Tools: DAE Tools is a cross-platform equation-oriented process modeling and optimization software. Various types of processes (lumped or distributed, steady-state or dynamic) can be modelled and optimized. Equations can be ordinary or discontinuous, where discontinuities are automatically handled by the framework. The simulation/optimization results can be plotted and/or exported into various formats. Currently, Sundials IDAS solver is used to solve DAE systems and calculate sensitivities, BONMIN, IPOPT, and NLOPT solvers are used to solve NLP/MINLP problems, while various direct/iterative sparse matrix linear solvers are interfaced: SuperLU and SuperLU_MT, Intel Pardiso, AMD ACML, Trilinos Amesos (KLU, Umfpack, SuperLU, Lapack), and Trilinos AztecOO (with built-in, Ifpack or ML preconditioners). Linear solvers that exploit GPGPUs are also available (SuperLU_CUDA, CUSP; still in an early development stage).

  • ODES: ODES offers python bindings to the SUNDIALS ode/dae solvers (CVODE and IDA), which are state-of-the-art BDF linear multistep methods for stiff problems and Adams-Moulton linear multistep method for nonstiff problems with wide industrial use. The package has a low learning curve, with great flexibility to the user.

  • Mousai: Mousai can solve sets of first-order and second-order ordinary differential equations written in state-space form (solved for acceleration for second-order form) subject to a harmonic excitation. All you need to provide is the name of a Python function, which may simply be a wrapper to an external code.

Economics and econometrics

  • pyTrix: a small set of utilities for economics and econometrics, including pyGAUSS (GAUSS command analogues for use in SciPy).

  • pandas: data structures and tools for cross-sectional and time series data sets.

Electromagnetics and electrical engineering

  • FiPy: see entry in `Miscellaneous`.

  • FEval: see entry in `Miscellaneous`.

  • EMPy (Electromagnetic Python): various common algorithms for electromagnetic problems and optics, including the transfer matrix algorithm and rigorous coupled wave analysis.

  • Optics of multilayer films: including the transfer-matrix method, coherent and incoherent propagation, and depth-dependent absorption profiles.

  • openTMM: an electrodynamic S-matrix (transfer matrix) code with modern applications.

  • pyLuminous: optical modeling of dielectric interfaces and a transfer-matrix solver (including a useful case of uniaxial layers). Includes pyQW for modelling of very simple quantum well structures and their intersubband transitions.

  • pyofss: analyzes optical fibre telecommunication systems, including numerically integrating the appropriate appropriate Schrödinger-type equation to calculate fibre dispersion.

  • ThunderStorm: a library for ElectroStatic-Discharge (ESD) Transmission Line Pulse (TLP) measurement data analysis.

  • electrode: a toolkit to develop and analyze rf surface ion traps.

  • scikit-rf: compilation of functions for microwave/RF engineering. Useful for tasks such as calibration, data analysis, data acquisition, and plotting functions.

  • netana: electronic Network Analyzer, solves electronic AC & DC Mash and Node network equations using matrix algebra.

Geosciences

  • CDAT: (Climate Data Analysis Tools) is a suite of tools for analysis of climate models.

  • Jeff Whitaker: has made a number of useful tools for atmospheric modelers, including the basemap toolkit for matplotlib, and a NumPy-compatible netCDF4 interface.

  • seawater: a package for computing properties of seawater (UNESCO 1981 and UNESCO 1983).

  • atmqty: computes atmospheric quantities on the Earth.

  • TAPPy - Tidal Analysis Program in Python: decomposes an hourly time series of water levels into tidal components. It uses SciPy’s least squares optimization.

  • ClimPy: a hydrology-oriented library.

  • GIS Python: Python programs and libraries for geodata processing.

  • SimPEG: simulation and parameter estimation in geophysics (including 3D forward modeling and inversion routines for electromagnetics, magnetotellurics, direct-current resistivity, magnetics, and gravity).

Molecular modeling

  • Biskit: an object-oriented platform for structural bioinformatics research. Structure and trajectory objects tightly integrate with NumPy allowing, for example, for fast take and compress operations on molecules or trajectory frames. Biskit integrates many external programs (e.g., XPlor, Modeller, Amber, DSSP, T-Coffee, Hmmer, etc.) into workflows and supports parallelization.

  • PyMOL: a molecular graphics system with an embedded Python interpreter designed for real-time visualization and rapid generation of high-quality molecular graphics and animations.

  • UCSF Chimera: UCSF Chimera is a highly extensible, interactive molecular graphics program. It is the successor to UCSF Midas and MidasPlus; however, it has been completely redesigned to maximize extensibility and leverage advances in hardware. UCSF Chimera can be downloaded free of charge for academic, government, non-profit, and personal use.

  • The Python Macromolecular Library (mmLib): a software toolkit and library of routines for the analysis and manipulation of macromolecular structural models. It provides a range of useful software components for parsing mmCIF, PDB, and MTZ files, a library of atomic elements and monomers, an object-oriented data structure describing biological macromolecules, and an OpenGL molecular viewer.

  • MDTools for Python: MDTools is a Python module which provides a set of classes useful for the analysis and modification of protein structures. Current capabilities include reading psf files, reading and writing (X-PLOR style) pdb and dcd files, calculating phi-psi angles and other properties for arbitrary selections of residues, and parsing output from NAMD into an easy-to-manipulate data object.

  • BALL - Biochemical Algorithms Library: a set of libraries and applications for molecular modeling and visualization. OpenGL and Qt are the underlying C++ layers; some components are LGPL-licensed, others GPL.

  • SloppyCell: SloppyCell is a software environment for simulation and analysis of biomolecular networks developed by the groups of Jim Sethna and Chris Myers at Cornell University.

  • PyVib2: a program for analyzing vibrational motion and vibrational spectra. The program is supposed to be an open-source “all-in-one” solution for scientists working in the field of vibrational spectroscopy (Raman and IR) and vibrational optical activity (ROA and VCD). It is based on NumPy, matplotlib, VTK, and Pmw.

  • ASE: an atomistic simulation environment written in Python with the aim of setting up, stearing, and analyzing atomistic simulations. It can use a number of backend calculation engines (e.g., Abinit, Siesta, Vasp, Dacapo, GPAW, etc.) to perform ab-initio calculations within Density Functional Theory. It can do total energy calculations, molecular dynamics, geometry optimization, and much more. There is also a GUI and visualization tools for interactive work.

  • PyEMMA: (EMMA = Emma’s Markov Model Algorithms) is an open source Python/C package for analysis of extensive molecular dynamics simulations. In particular, it includes algorithms for estimation, validation, and analysis of Markov state models, a popular toolset to gain insight on the kinetics of the simulation. It provides collective variables calculation, clustering methods, time lagged independent component analysis (TICA), and model estimation for Markov state models, hidden Markov models, and multi ensemble simulation like umbrella sampling. In addition, transition path theory can be applied to these models, which allows for kinetic pathway extraction and flux computations via transition networks.

Signal processing

  • GNU Radio: a free software development toolkit that provides the signal processing runtime and processing blocks to implement software radios using readily-available, low-cost external RF hardware and commodity processors. GNU Radio applications are primarily written using the Python programming language, while the supplied, performance-critical signal processing path is implemented in C++ using processor floating point extensions, where available. Thus, the developer is able to implement real-time, high-throughput radio systems in a simple-to-use, rapid-application-development environment. While not primarily a simulation tool, GNU Radio does support development of signal processing algorithms using pre-recorded or generated data, avoiding the need for actual RF hardware.

  • pysamplerate: a small wrapper for Source Rabbit Code (http://www.mega-nerd.com/SRC/), still incomplete, but can be used now for high-quality resampling of audio signals, even for a non-rational ratio.

  • audiolab: a small library to import data from audio files to NumPy arrays and export NumPy arrays to audio files. It uses libsndfile for the IO (http://www.mega-nerd.com/libsndfile/), which means many formats are available, including wav, aiff, HTK format, and FLAC, an open-source lossless compressed format. Previously known as pyaudio (not to confuse with pyaudio), now part of scikits.

  • PyWavelets: a user-friendly Python package to compute various kinds of Discrete Wavelet Transform.

  • PyAudiere: a very flexible and easy-to-use audio library for Python users. Available methods allow you to read sound files of various formats into memory and play or stream them (if they are large). You can pass sound buffers as NumPy arrays of float32’s to play (non-blocking). You can also create pure tones, square waves, or ‘on-line’ white or pink noise. All of these functions can be utilized concurrently.

  • CMU Sphinx: a free automatic speech recognition system. The SphinxTrain package for training acoustic models includes Python modules for reading and writing Sphinx-format acoustic feature and HMM parameter files to/from NumPy arrays.

Symbolic math, number theory, etc.

  • NZMATH: NZMATH is a Python-based number-theory-oriented calculation system developed at Tokyo Metropolitan University. It contains routines for factorization, gcd, lattice reduction, factorial, finite fields, and other such goodies. Unfortunately, it is short on documentation, but contains a lot of useful stuff if you can find it.

  • SAGE: a comprehensive environment with support for research in algebra, geometry, and number theory. It wraps existing libraries and provides new ones for elliptic curves, modular forms, linear and non-commutative algebra, and a lot more.

  • SymPy: SymPy is a Python library for symbolic mathematics. It aims to become a full-featured computer algebra system (CAS), while keeping the code as simple as possible in order to be comprehensible and easily extensible. SymPy is written entirely in Python and does not require any external libraries, except optionally for plotting support.

  • Python bindings for CLNUM: a library which provides exact rationals and arbitrary precision floating point, orders of magnitude faster (and more full-featured) than the Decimal.py module from Python’s standard library. From the same site, the ratfun module provides rational function approximations, and rpncalc is a full RPN interactive Python-based calculator.

  • Kayali: a Qt-based Computer Algebra System (CAS) written in Python. It is essentially a frontend GUI for Maxima and Gnuplot.

Quantum mechanics

  • QuTiP: a numerical framework for simulating the dynamics of open and closed quantum systems.

  • QNET: a package to aid in the design and analysis of photonic circuit models.

  • PyQuante: a suite of programs for developing quantum chemistry methods.

  • QmeQ: a package for calculations of transport through quantum dot devices.

Miscellaneous

  • These are just other links which may be very useful to scientists, but which I don’t quite know how to categorize, or for which I didn’t want to make a single-link category.

  • IDL to Numeric/numarray Mapping: a summary mapping between IDL and numarray. Most of the mapping also applies to Numeric.

  • Pybliographer: a tool for managing bibliographic databases. It can be used for searching, editing, reformatting, etc. In fact, it’s a simple framework that provides easy-to-use Python classes and functions, and therefore can be extended to many uses (generating HTML pages according to bibliographic searches, etc). In addition to the scripting environment, a graphical Gnome interface is available. It provides powerful editing capabilities, a nice hierarchical search mechanism, direct insertion of references into LyX and Kile, direct queries on Medline, and more. It currently supports the following file formats: BibTeX, ISI, Medline, Ovid, Refer.

  • Vision Egg: a powerful, flexible, and free way to produce stimuli for vision research experiments.

  • Easyleed: a tool for the automated extraction of intensity-energy spectra from low-energy electron diffraction experiments commonly performed in condensed matter physics.

  • PsychoPy: a freeware library for vision research experiments (and data analysis) with an emphasis on psychophysics.

  • PyEPL: the Python Experiment Programing Library. A free library to create experiments ranging from simple display of stimuli and recording of responses (including audio) to the creation of interactive virtual reality environments.

  • Module dependency graph: a few scripts to glue modulefinder.py into graphviz, producing import dependency pictures pretty enough for use as a poster, and containing enough information to be a core part of the process for understanding physical dependencies.

  • Modular toolkit for Data Processing (MDP): a library to implement data processing elements (nodes) and to combine them into data processing sequences (flows). Already implemented nodes include Principal Component Analysis (PCA), Independent Component Analysis (ICA), Slow Feature Analysis (SFA), and Growing Neural Gas.

  • FiPy: FiPy is an object-oriented, partial differential equation (PDE) solver, written in Python, based on a standard finite volume (FV) approach. The framework has been developed in the Metallurgy Division and Center for Theoretical and Computational Materials Science (CTCMS), in the Material Measurement Laboratory (MML) at the National Institute of Standards and Technology (NIST).

  • SfePy: SfePy is a software for solving systems of coupled partial differential equations (PDEs) by the finite element method in 2D and 3D. It can be viewed both as a black-box PDE solver, and as a Python package which can be used for building custom applications. The time-demanding parts are implemented in C/Cython.

  • Hermes: Hermes is a free C++/Python library for rapid prototyping of adaptive FEM and hp-FEM solvers developed by an open-source community around the hp-FEM group at the University of Nevada, Reno.

  • FEval: FEval is useful for conversion between many finite element file formats. The main functionality is extraction of model data in the physical domain, for example to calculate flow lines.

  • peak-o-mat: peak-o-mat is a curve-fitting program for the spectroscopist. It is especially designed for batch cleaning, conversion ,and fitting of spectra from visible optics experiments if you’re facing a large number of similar spectra.

  • SciPyAmazonAmi: add software you would like installed on a publicly available Amazon EC2 image here.

  • xarray: a library that allows for the labeling of any dimension in a multidimensional array.

  • PyCVF: a computer vision and video mining Framework.

  • CNEMLIB : proposes an implementation of CNEM in 2D and 3D. The CNEM is a generalisation for non-convex domain of the Natural Element Method. It’s a FEM-like approach. The main functionalities of CNEMLIB are: i) interpolation of scattered data spread on convex or non convex domains with the Natural Neighbour interpolant (Sibson) in 2D, and the Natural Neighbor interpolant (Sibson or Laplace) or the linear finite element interpolant over the Delaunay tessellation in 3D. ii) a gradient matrix operator which allows to calculate nodal gradients for scattered data (the approach used is based on the stabilized nodal integration, SCNI). iii) a general assembling tools to construct assembled matrix associated with a weak formulation (heat problem, mechanic problem, hydrodynamic problem, general purpose problem) as such used with the Finite Element Method (FEM).

  • aestimo: models quantum well semiconductor heterostructure using a 1-D self-consistent Schrödinger-Poisson solver. Contains a shooting method solver and a finite element k.p solver.

  • plotexplorer_gui: a wxpython/matplotlib script for plotting and contrasting a collection of graphs via a sortable checkbox list.

  • VibrationTesting: tools for signal processing, model solution, model manipulation, and system and modal identification of linear vibratory systems.

  • Vibration_Toolbox: educational set of tools intended primarily for the demonstration of vibration analysis and phenomenon. You may find them useful for application, but that isn’t the intent of this module.

  • Colour: a package implementing a comprehensive number of color theory transformations and algorithms.

  • PyBaMM: fast and flexible physics-based battery models.

Table of Contents

Search