LFX Platform

Know more about LFX Platform

LFX Insights

Scientific Computing Libraries

Libraries for numerical and scientific computation, simulation, and advanced mathematical analysis.

119 projects

133,782 contributors

$4.7B

Pandas

Flexible and powerful data analysis / manipulation library for Python, providing labeled data structures similar to R data.frame objects, statistical functions, and much more

Contributors

23,246

Organizations

3,536

Software value

$25M

NumPy

NumPy is a Python library for numerical computing, providing support for multi-dimensional arrays, mathematical functions, and efficient operations on large datasets.

Contributors

10,038

Organizations

2,258

Software value

$24M

SciPy

SciPy is a Python library that builds on NumPy to provide advanced algorithms for scientific computing, including optimization, integration, signal processing, and linear algebra.

Contributors

9,989

Organizations

2,053

Software value

$30M

SymPy

SymPy is a Python library for symbolic mathematics that provides computer algebra system (CAS) capabilities. It enables users to perform symbolic calculations, algebraic manipulations, calculus operations, and mathematical computations with exact precision rather than numerical approximations.

Contributors

6,540

Organizations

1,098

Software value

$25M

JAX

JAX is a high-performance numerical computing and machine learning library that combines Numpy's familiar API with GPU and TPU hardware acceleration. It features automatic differentiation, just-in-time compilation, and enables writing transformable numerical programs.

Contributors

6,126

Organizations

1,126

Software value

$20M

SageMath

Main repository of SageMath

Contributors

3,762

Organizations

262

Software value

$100M

Numba

Numba is a Just-In-Time (JIT) compiler that translates a subset of Python and NumPy code into fast machine code, specializing in numerical computing and scientific applications. It enables Python functions to be compiled to native machine instructions, significantly improving performance for computationally intensive operations.

Contributors

3,617

Organizations

870

Software value

$9.9M

Dask

Dask is a flexible parallel computing library for analytics that provides dynamic task scheduling optimized for computation and integrates with Python data science libraries like NumPy, Pandas and Scikit-learn. It enables parallel and distributed computing through intuitive APIs and scales Python code from multi-core machines to clusters.

Contributors

3,567

Organizations

901

Software value

$6.8M

statsmodels

Statsmodels is a Python library for statistical modeling and econometrics that provides classes and functions for estimating various statistical models, conducting statistical tests, and exploring statistical data. It includes linear regression models, time series analysis, discrete choice models, and many other statistical methods.

Contributors

3,380

Organizations

606

Software value

$24M

xarray

Xarray is a Python library that introduces labeled arrays and datasets, extending NumPy's capabilities by adding coordinates, dimensions, and attributes to N-dimensional arrays. It enables working with multi-dimensional data by providing data structures and operations for labeled arrays, making it particularly useful for scientific computing and analysis of structured data like climate and weather data.

Contributors

2,968

Organizations

700

Software value

$6.5M

Astropy

Astropy is a core package for astronomy in Python that provides tools and functionality for performing astronomical calculations, handling astronomical data, working with coordinates, time, units, and other common astronomy-related tasks. It serves as a foundational library for the astronomical computing ecosystem.

Contributors

2,764

Organizations

585

Software value

$20M

OpenBLAS

OpenBLAS is a high-performance open-source implementation of the Basic Linear Algebra Subprograms (BLAS) library, optimized for various processor architectures. It provides efficient matrix and vector operations essential for scientific computing, machine learning, and numerical analysis.

Contributors

2,577

Organizations

558

Software value

$165M

PyMC

Bayesian Modeling and Probabilistic Programming in Python

Contributors

2,510

Organizations

461

Software value

$3.3M

Qiskit

Qiskit is an open-source software development kit for quantum computing that enables users to create, manipulate and run quantum circuits on quantum computers and simulators. It provides tools for quantum programming, algorithm development, hardware access, and quantum education.

Contributors

2,470

Organizations

267

Software value

$17M

RDKit

RDKit is an open-source cheminformatics and machine learning software toolkit that provides functionality for processing, analyzing, and manipulating chemical structures. It includes tools for 2D and 3D molecular operations, chemical fingerprinting, molecular descriptor calculation, substructure searching, and integration with popular data science frameworks.

Contributors

2,293

Organizations

337

Software value

$49M

MOOSE

MOOSE (Multiphysics Object-Oriented Simulation Environment) is a finite element framework developed by Idaho National Laboratory for solving complex engineering and scientific problems. It provides a flexible, parallel computational framework for coupled systems of nonlinear partial differential equations.

Contributors

2,067

Organizations

78

Software value

$101M

Biopython

Biopython is an open-source library of tools for biological computation written in Python. It provides modules for working with biological sequences, file parsers for various bioinformatics file formats, access to online biological databases, and tools for performing common bioinformatics operations.

Contributors

2,063

Organizations

380

Software value

$62M

AliPhysics

AliPhysics is a physics analysis framework for analyzing data from high-energy particle physics experiments, particularly focused on heavy-ion collisions. It provides tools and algorithms for particle reconstruction, event analysis, and data processing in nuclear physics research.

Contributors

1,843

Organizations

22

Software value

$272M

Math.js

Math.js is an extensive mathematics library for JavaScript that provides a flexible expression parser and offers support for symbolic computation, complex numbers, units, matrices, and a wide range of mathematical functions. It can be used both in Node.js and in web browsers.

Contributors

1,802

Organizations

417

Software value

$3.6M

ROOT

ROOT is a scientific software framework developed at CERN that provides tools for big data processing, statistical analysis, visualization and storage in high-energy physics research. It includes a C++ interpreter, advanced statistical tools, machine learning capabilities, and powerful graphics tools for data visualization.

Contributors

1,788

Organizations

253

Software value

$293M

h5py

h5py is a Pythonic interface to the HDF5 binary data format, providing a high-level interface for storing and organizing large amounts of numerical data. It allows Python programs to store huge amounts of numerical data in a hierarchical format, and efficiently manipulate that data from NumPy.

Contributors

1,546

Organizations

475

Software value

$1.1M

Trilinos

The mission of the Project is the creation of algorithms and enabling technologies for the solution of large-scale, complex multi-physics engineering and scientific problems on new and emerging high-performance computing (HPC) architectures. The Project is composed of packages addressing various computational needs of engineering and scientific simulations.

Contributors

1,370

Organizations

118

Software value

$654M

LAMMPS

LAMMPS (Large-scale Atomic/Molecular Massively Parallel Simulator) is a classical molecular dynamics simulation code designed to efficiently compute atomic, polymeric, biological, metallic, granular, and coarse-grained systems using various interatomic potentials and boundary conditions on parallel computers.

Contributors

1,357

Organizations

167

Software value

$69M

OpenMM

OpenMM is a toolkit for molecular simulation using high performance GPU code.

Contributors

1,349

Organizations

203

Software value

$40M

Pymatgen

Pymatgen (Python Materials Genomics) is a robust, open-source Python library for materials analysis. It provides core functionality for analyzing materials science data, performing crystallographic operations, generating phase diagrams, and analyzing electronic structures. The library serves as a key component in the Materials Project ecosystem for computational materials science research.

Contributors

1,245

Organizations

132

Software value

$49M

MFEM

MFEM is a free, lightweight, scalable C++ library for finite element methods. It provides high-performance mathematical algorithms for finite element discretization, linear algebra operations, mesh representation, and parallel computing capabilities for solving partial differential equations.

Contributors

1,087

Organizations

94

Software value

$18M

NIPYPE

NIPYPE is a Python-based neuroimaging data processing framework that provides a uniform interface to existing neuroimaging software and facilitates interaction between these packages within a single workflow. It enables reproducible, distributed analysis of neuroimaging data through workflows and interfaces to commonly used neuroimaging tools.

Contributors

1,038

Organizations

193

Software value

$7.2M

deal.II

deal.II is an open-source finite element analysis library designed for computational science and numerical simulations. It provides tools and algorithms for solving partial differential equations using adaptive finite element methods, with particular focus on scientific computing and engineering applications.

Contributors

1,032

Organizations

107

Software value

$154M

Drake

Drake is a robotics toolbox and model-based design tool for analyzing and controlling robotic systems. It provides a comprehensive suite of tools for simulation, optimization, and control of complex robotic systems, with support for rigid body dynamics, trajectory optimization, and control system design.

Contributors

1,020

Organizations

150

Software value

$32M

Energy Exascale Earth System Model (E3SM)

The Energy Exascale Earth System Model (E3SM) is a state-of-the-art Earth system model developed for high-performance computing to address challenging climate science problems. It focuses on modeling Earth's water cycle, biogeochemistry, and cryosphere systems at high resolution.

Contributors

989

Organizations

44

Software value

$75M

stdlib

stdlib is a comprehensive standard library for JavaScript and Node.js that provides a collection of mathematical, statistical, and scientific computing functions, along with utilities for data processing, machine learning, and numerical computing

Contributors

964

Organizations

142

Software value

$324M

ITK

ITK (Insight Toolkit) is an open-source, cross-platform library providing an extensive suite of software tools for image analysis, focusing on medical image processing and registration. It offers algorithms for segmentation, registration, filtering, and analysis of multi-dimensional scientific images.

Contributors

958

Organizations

145

Software value

$77M

SU2

SU2 is an open-source suite of tools for performing computational fluid dynamics (CFD) simulations and solving partial differential equations. It is designed for aerodynamic shape optimization and is capable of simulating compressible, incompressible, and multiphysics flows.

Contributors

859

Organizations

53

Software value

$21M

OpenModelica

OpenModelica is an open-source Modelica-based modeling and simulation environment intended for industrial and academic usage. It supports model-based design and simulation of complex physical systems in multiple domains including mechanical, electrical, electronic, hydraulic, thermal, control, and electric power systems.

Contributors

858

Organizations

74

Software value

$70M

PyBaMM

PyBaMM (Python Battery Mathematical Modelling) is an open-source battery simulation package that enables fast and flexible simulations of battery models. It provides a unified framework for implementing and solving various physics-based battery models, from simple lumped parameter models to complex multiphysics simulations.

Contributors

844

Organizations

66

Software value

$6.1M

ALICE O2

ALICE O2 (Online-Offline) is a computing system and software framework for the ALICE experiment at CERN. It handles data acquisition, reconstruction, calibration, and analysis for high-energy physics experiments, specifically designed to process data from heavy-ion collisions at the Large Hadron Collider.

Contributors

819

Organizations

30

Software value

$48M

Zarr

Zarr is a format and library for chunked, compressed N-dimensional arrays, designed for efficient storage and access of large scientific datasets. It provides a Python implementation with support for cloud storage, parallel computing, and hierarchical organization of arrays.

Contributors

816

Organizations

291

Software value

$1.5M

Psi4

Open-Source Quantum Chemistry – an electronic structure package in C++ driven by Python

Contributors

809

Organizations

112

Software value

$29M

AMReX

The mission and charitable purposes (collectively, the “Charitable Purposes”) of the Project is to provide a parallel, performance-portable block-structured adaptive mesh refinement framework for science and engineering applications.

Contributors

789

Organizations

74

Software value

$199M

Firedrake

Firedrake is an automated system for the portable solution of partial differential equations using the finite element method (FEM)

Contributors

787

Organizations

85

Software value

$10M

GEOS-Chem

GEOS-Chem is a global 3-D chemical transport model for atmospheric composition that simulates atmospheric chemistry, aerosols, and greenhouse gases. It is used by research groups worldwide for studying atmospheric chemistry and composition, air quality, and climate change.

Contributors

741

Organizations

16

Software value

$18M

Kratos Multiphysics

Kratos Multiphysics is an open-source framework for the implementation of numerical methods for solving engineering problems, particularly focused on finite element methods, computational fluid dynamics, and structural mechanics. It provides a unified environment for multi-physics simulations with parallel processing capabilities.

Contributors

733

Organizations

47

Software value

$124M

netCDF4-python

netcdf4-python: python/numpy interface to the netCDF C library

Contributors

728

Organizations

203

Software value

$672K

SpikeInterface

A Python-based module for creating flexible and robust spike sorting pipelines.

Contributors

701

Organizations

56

Software value

$4.1M

FieldTrip

The MATLAB toolbox for MEG, EEG and iEEG analysis

Contributors

688

Organizations

70

Software value

$23M

ModelingToolkit.jl

ModelingToolkit.jl is a symbolic modeling framework for scientific computing and automated model transformation in Julia. It enables users to define, manipulate, and solve complex mathematical models through symbolic computation, automatic differentiation, and code generation capabilities.

Contributors

662

Organizations

155

Software value

$1.9M

wxMaxima

A gui for the computer algebra system Maxima built with wxWidgets

Contributors

650

Organizations

87

Software value

$5.7M

Symbolics.jl

Symbolic programming for the next generation of numerical software

Contributors

642

Organizations

164

Software value

$563K

Unidata NetCDF

NetCDF (Network Common Data Form) is a set of software libraries and machine-independent data formats that support the creation, access, and sharing of array-oriented scientific data. This C implementation provides the reference library and tools for working with NetCDF files, enabling efficient storage and retrieval of multi-dimensional scientific data.

Contributors

639

Organizations

172

Software value

$20M

Mantid

Mantid (Manipulation and Analysis Toolkit for Instrument Data) is a scientific software framework for processing and analyzing neutron and muon scattering data from large-scale facilities. It provides tools for data reduction, visualization, and analysis used by scientists at neutron and muon sources worldwide.

Contributors

601

Organizations

42

Software value

$93M

WarpX

The mission and charitable purposes (collectively, the “Charitable Purposes”) of the Project is to provide a community, performance-portable and modular Particle in-Cell code with advanced algorithms.

Contributors

599

Organizations

56

Software value

$12M

PowSyBl

PowSyBl (Power System Blocks) is an open source library dedicated to electrical grid modeling and simulation. PowSyBl is written in Java and licensed under the Mozilla Public License 2.0. PowSyBl may be scripted for a quick solution, but it can also be used as a library to write complex software for power system simulation and analysis. Using PowSyBl, developers can create applications able to perform dynamic power flow simulations and security analyses on the network, handle a variety of formats including CGMES for European data exchanges, and many other tasks. PowSyBl has a completely modular design, enabling developers to extend or customize its features by providing their own plugins. Modularity is a key value of PowSyBl’s open source design.

Contributors

596

Organizations

54

Software value

$692M

OrdinaryDiffEq.jl

OrdinaryDiffEq.jl is a high-performance solver package for ordinary differential equations (ODEs) in Julia. It provides a comprehensive suite of numerical methods for solving various types of ODEs, including stiff and non-stiff problems, with features for automatic algorithm selection and performance optimization.

Contributors

585

Organizations

139

Software value

$6.4M

CaImAn

Computational toolbox for large scale Calcium Imaging Analysis, including movie handling, motion correction, source extraction, spike deconvolution and result visualization.

Contributors

557

Organizations

66

Software value

$1.5M

PyCBC

Core package to analyze gravitational-wave data, find signals, and study their parameters. This package was used in the first direct detection of gravitational waves (GW150914), and is used in the ongoing analysis of LIGO/Virgo data.

Contributors

555

Organizations

38

Software value

$13M

Stan

Stan is a state-of-the-art platform for statistical modeling and high-performance statistical computation. It provides a probabilistic programming language for specifying statistical models and implements gradient-based Markov Chain Monte Carlo (MCMC) sampling for Bayesian inference.

Contributors

543

Organizations

108

Software value

$3.3M

QCoDeS

Modular data acquisition framework

Contributors

541

Organizations

45

Software value

$7.9M

DOLFINx

DOLFINx is a high-performance finite element library and computational framework for solving partial differential equations (PDEs). It is part of the FEniCS Project, providing efficient tools for automated solution of differential equations through high-level Python and C++ interfaces.

Contributors

489

Organizations

58

Software value

$2.4M

FreeSurfer

Neuroimaging analysis and visualization suite

Contributors

446

Organizations

62

Software value

$68M

Gammapy

A Python package for gamma-ray astronomy

Contributors

420

Organizations

53

Software value

$4.2M

Looking for a project that’s not listed?