237 lines
24 KiB
Plaintext
237 lines
24 KiB
Plaintext
[38;5;12m [39m[38;2;255;187;0m[1m[4mAwesome Scientific Computing [0m[38;5;14m[1m[4m![0m[38;2;255;187;0m[1m[4mAwesome[0m[38;5;14m[1m[4m (https://awesome.re/badge.svg)[0m[38;2;255;187;0m[1m[4m (https://awesome.re)[0m
|
||
|
||
[38;5;12m (#readme)[39m
|
||
|
||
[38;5;11m[1m▐[0m[38;5;12m [39m[38;5;12mUseful resources for scientific computing and numerical analysis.[39m
|
||
|
||
[38;5;12mScientific computing and numerical analysis are research fields that aim to provide[39m
|
||
[38;5;12mmethods for solving large-scale problems from various areas of science with the help of[39m
|
||
[38;5;12mcomputers. Typical problems are ordinary and partial differential equations (ODEs,[39m
|
||
[38;5;12mPDEs), their discretizations, and the solution of linear algebra problems arising from[39m
|
||
[38;5;12mthem.[39m
|
||
|
||
[38;2;255;187;0m[4mContents[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mBasic linear algebra[0m[38;5;12m (#basic-linear-algebra)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMulti-purpose toolkits[0m[38;5;12m (#multi-purpose-toolkits)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mFinite Elements[0m[38;5;12m (#finite-elements)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMeshing[0m[38;5;12m (#meshing)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mData formats[0m[38;5;12m (#data-formats)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mSparse linear solvers[0m[38;5;12m (#sparse-linear-solvers)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mVisualization[0m[38;5;12m (#visualization)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mOther libraries and tools[0m[38;5;12m (#other-libraries-and-tools)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mCommunity[0m[38;5;12m (#community)[39m
|
||
|
||
[38;2;255;187;0m[4mBasic linear algebra[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mBLAS[0m[38;5;12m (https://netlib.org/blas/) - Standard building blocks for performing basic vector and matrix operations.[39m
|
||
[38;5;12m (Fortran, public domain, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/Reference-LAPACK/lapack/tree/master/BLAS))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mOpenBLAS[0m[38;5;12m (https://www.openblas.net) - Optimized BLAS library based on GotoBLAS2.[39m
|
||
[38;5;12m (C and Assembly, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/OpenMathLib/OpenBLAS))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mBLIS[0m[38;5;12m (https://github.com/flame/blis) - High-performance BLAS-like dense linear algebra libraries.[39m
|
||
[38;5;12m (C, BSD, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mLAPACK[0m[38;5;12m (https://netlib.org/lapack/) - Routines for solving systems of linear equations, linear least-squares, eigenvalue problems, etc.[39m
|
||
[38;5;12m (Fortran, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/Reference-LAPACK/lapack))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mEigen[0m[38;5;12m (https://eigen.tuxfamily.org/index.php?title=Main_Page) - C++ template library for linear algebra.[39m
|
||
[38;5;12m (C++, MPL 2, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.com/libeigen/eigen))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mGinkgo[0m[38;5;12m (https://ginkgo-project.github.io/) - High-performance manycore linear algebra library, focus on sparse systems.[39m
|
||
[38;5;12m (C++, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/ginkgo-project/ginkgo))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mblaze[0m[38;5;12m (https://bitbucket.org/blaze-lib/blaze) - High-performance C++ math library for dense and sparse arithmetic.[39m
|
||
[38;5;12m (C++, BSD, Bitbucket)[39m
|
||
|
||
[38;2;255;187;0m[4mMulti-purpose toolkits[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mPETSc[0m[38;5;12m (https://www.mcs.anl.gov/petsc/) - Parallel solution of scientific applications modeled by PDEs.[39m
|
||
[38;5;12m (C, 2-clause BSD, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.com/petsc/petsc))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mDUNE Numerics[0m[38;5;12m (https://www.dune-project.org) - Toolbox for solving PDEs with grid-based methods.[39m
|
||
[38;5;12m (C++, GPL 2, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.dune-project.org/core/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mSciPy[0m[38;5;12m (https://scipy.org) - Python modules for statistics, optimization, integration, linear algebra, etc.[39m
|
||
[38;5;12m (Python, mostly BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/scipy/scipy/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mNumPy[0m[38;5;12m (https://numpy.org/) - Fundamental package needed for scientific computing with Python.[39m
|
||
[38;5;12m (Python, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/numpy/numpy))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mDifferentialEquations.jl[0m[38;5;12m (https://diffeq.sciml.ai/) - Toolbox for solving different types of differential equations numerically. (Julia, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/SciML/DifferentialEquations.jl))[39m
|
||
|
||
[38;2;255;187;0m[4mFinite Elements[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mFEniCS[0m[38;5;12m (https://fenicsproject.org) - Computing platform for solving PDEs in Python and C++.[39m
|
||
[38;5;12m (C++/Python, LGPL 3, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/FEniCS)/[39m[38;5;14m[1mBitbucket[0m[38;5;12m (https://bitbucket.org/fenics-project/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mlibMesh[0m[38;5;12m (https://libmesh.github.io) - Framework for the numerical simulation of PDEs using unstructured discretizations.[39m
|
||
[38;5;12m (C++, LGPL 2.1, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/libMesh/libmesh))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mdeal.II[0m[38;5;12m (https://dealii.org) - Software library supporting the creation of finite element codes.[39m
|
||
[38;5;12m (C++, LGPL 2.1, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/dealii/dealii))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mNetgen/NGSolve[0m[38;5;12m (https://ngsolve.org) - High performance multiphysics finite element software.[39m
|
||
[38;5;12m (C++, LGPL 2.1, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/NGSolve/netgen))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mFiredrake[0m[38;5;12m (https://www.firedrakeproject.org) - Automated system for the solution of PDEs using the finite element method.[39m
|
||
[38;5;12m (Python, LGPL 3, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/firedrakeproject/firedrake))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMOOSE[0m[38;5;12m (https://mooseframework.inl.gov/) - Multiphysics Object Oriented Simulation Environment.[39m
|
||
[38;5;12m (C++, LGPL 2.1, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/idaholab/moose))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMFEM[0m[38;5;12m (https://mfem.org) - Free, lightweight, scalable C++ library for finite element methods.[39m
|
||
[38;5;12m (C++, BSD-3-Clause, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/mfem/mfem))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mSfePy[0m[38;5;12m (https://sfepy.org) - Simple Finite Elements in Python.[39m
|
||
[38;5;12m (Python, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/sfepy/sfepy))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mFreeFEM[0m[38;5;12m (https://freefem.org) - High level multiphysics-multimesh finite element language.[39m
|
||
[38;5;12m (C++, LGPL, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/FreeFem))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mlibceed[0m[38;5;12m (https://libceed.readthedocs.io/en/latest/index.html) - Code for Efficient Extensible Discretizations.[39m
|
||
[38;5;12m (C, 2-clause BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/CEED/libCEED))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mscikit-fem[0m[38;5;12m (https://github.com/kinnala/scikit-fem) - Simple finite element assemblers.[39m
|
||
[38;5;12m (Python, BSD/GPL, GitHub)[39m
|
||
|
||
[38;2;255;187;0m[4mMeshing[0m
|
||
|
||
[38;2;255;187;0m[4mTriangular and tetrahedral meshing[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mGmsh[0m[38;5;12m (https://gmsh.info) - Three-dimensional finite element mesh generator with pre- and post-processing facilities.[39m
|
||
[38;5;12m (C++, GPL, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.onelab.info/gmsh/gmsh))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mpygmsh[0m[38;5;12m (https://github.com/nschloe/pygmsh) - Python interface for Gmsh.[39m
|
||
[38;5;12m (Python, GPL 3, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMeshPy[0m[38;5;12m (https://mathema.tician.de/software/meshpy/) - Quality triangular and tetrahedral mesh generation.[39m
|
||
[38;5;12m (Python, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/inducer/meshpy))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mCGAL[0m[38;5;12m (https://www.cgal.org) - Algorithms for computational geometry.[39m
|
||
[38;5;12m (C++, mixed LGPL/GPL, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/CGAL/cgal))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mpygalmesh[0m[38;5;12m (https://github.com/meshpro/pygalmesh) - Python interface for CGAL's 3D meshing capabilities.[39m
|
||
[38;5;12m (Python, GPL 3, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mTetGen[0m[38;5;12m (https://www.wias-berlin.de/software/index.jsp?id=TetGen) - Quality tetrahedral mesh generator and 3D Delaunay triangulator.[39m
|
||
[38;5;12m (C++, AGPLv3)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mTriangle[0m[38;5;12m (https://www.cs.cmu.edu/~quake/triangle.html) - Two-dimensional quality mesh generator and Delaunay triangulator.[39m
|
||
[38;5;12m (C, _nonfree software_)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mdistmesh[0m[38;5;12m (http://persson.berkeley.edu/distmesh/) - Simple generator for unstructured triangular and tetrahedral meshes.[39m
|
||
[38;5;12m (MATLAB, GPL 3)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mtrimesh[0m[38;5;12m (https://trimesh.org) - Loading and using triangular meshes with an emphasis on watertight surfaces.[39m
|
||
[38;5;12m (Python, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/mikedh/trimesh))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mdmsh[0m[38;5;12m (https://github.com/meshpro/dmsh) - Simple generator for unstructured triangular meshes, inspired by distmesh.[39m
|
||
[38;5;12m (Python, proprietary, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mTetWild[0m[38;5;12m (https://yixin-hu.github.io/tetwild.pdf) - Generate tetrahedral meshes for triangular surface meshes.[39m
|
||
[38;5;12m (C++, GPL 3, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/Yixin-Hu/TetWild))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mTriWild[0m[38;5;12m (https://cims.nyu.edu/gcl/papers/2019-TriWild.pdf) - Robust triangulation with curve constraints.[39m
|
||
[38;5;12m (C++, MPL 2, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/wildmeshing/TriWild))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mfTetWild[0m[38;5;12m (https://arxiv.org/abs/1908.03581) - Same as TetWild, but faster.[39m
|
||
[38;5;12m (C++, MPL 2, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/wildmeshing/fTetWild))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mSeismicMesh[0m[38;5;12m (https://github.com/krober10nd/SeismicMesh) - Parallel 2D/3D triangle/tetrahedral mesh generation with sliver removal.[39m
|
||
[38;5;12m (Python and C++, GPL 3, GitHub)[39m
|
||
|
||
[38;2;255;187;0m[4mQuadrilateral and hexahedral meshing[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mQuadriFlow[0m[38;5;12m (https://stanford.edu/~jingweih/papers/quadriflow/) - Scalable and robust quadrangulation from triangulation.[39m
|
||
[38;5;12m (C++, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/hjwdzh/QuadriFlow))[39m
|
||
|
||
[38;2;255;187;0m[4mMesh tools[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mmeshio[0m[38;5;12m (https://github.com/nschloe/meshio) - I/O for various mesh formats, file conversion.[39m
|
||
[38;5;12m (Python, MIT, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMOAB[0m[38;5;12m (https://sigma.mcs.anl.gov/moab-library/) - Representing and evaluating mesh data.[39m
|
||
[38;5;12m (C++, mostly LGPL 3, [39m[38;5;14m[1mBitbucket[0m[38;5;12m (https://bitbucket.org/fathomteam/moab/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1moptimesh[0m[38;5;12m (https://github.com/meshpro/optimesh) - Triangular mesh smoothing.[39m
|
||
[38;5;12m (Python, proprietary, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mpmp-library[0m[38;5;12m (https://www.pmp-library.org/) - Polygon mesh processing library.[39m
|
||
[38;5;12m (C++, MIT with Employer Disclaimer, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/pmp-library/pmp-library/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMmg[0m[38;5;12m (https://www.mmgtools.org/) - Robust, open-source & multidisciplinary software for remeshing.[39m
|
||
[38;5;12m (C, LGPL 3, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/MmgTools/mmg))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mmeshplex[0m[38;5;12m (https://github.com/meshpro/meshplex) - Fast tools for simplex meshes.[39m
|
||
[38;5;12m (Python, proprietary, GitHub)[39m
|
||
|
||
[38;2;255;187;0m[4mData formats[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mNetCDF[0m[38;5;12m (https://www.unidata.ucar.edu/software/netcdf/) - Software libraries and data formats for array-oriented scientific data.[39m
|
||
[38;5;12m (C/C++/Fortran/Java/Python, [39m[38;5;14m[1mcustom open-source[0m
|
||
[38;5;12m license[39m[38;5;14m[1m (https://www.unidata.ucar.edu/software/netcdf/copyright.html),[0m
|
||
[38;5;12m [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/Unidata/netcdf-c/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mHDF5[0m[38;5;12m (https://www.hdfgroup.org/solutions/hdf5/) - Data model, library, and file format for storing and managing data.[39m
|
||
[38;5;12m (C/Fortran, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/HDFGroup/hdf5))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mXDMF[0m[38;5;12m (https://xdmf.org/index.php/Main_Page) - eXtensible Data Model and Format for data from High Performance Computing codes.[39m
|
||
[38;5;12m (C++, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.kitware.com/xdmf/xdmf))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mZarr[0m[38;5;12m (https://zarr.readthedocs.io/en/stable/) - Format for the storage of chunked, compressed, N-dimensional arrays.[39m
|
||
[38;5;12m (Python, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/zarr-developers/zarr-python))[39m
|
||
|
||
[38;2;255;187;0m[4mSparse linear solvers[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mSuperLU[0m[38;5;12m (https://portal.nersc.gov/project/sparse/superlu/) - Direct solution of large, sparse, nonsymmetric systems of linear equations.[39m
|
||
[38;5;12m (C, mostly BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/xiaoyeli/superlu))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mPyAMG[0m[38;5;12m (https://pyamg.readthedocs.io/en/latest/) - Algebraic Multigrid Solvers in Python.[39m
|
||
[38;5;12m (Python, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/pyamg/pyamg))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mhypre[0m[38;5;12m (https://computing.llnl.gov/projects/hypre-scalable-linear-solvers-multigrid-methods) - Library of high-performance preconditioners and solvers.[39m
|
||
[38;5;12m (C, Apache 2.0/MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/hypre-space/hypre))[39m
|
||
|
||
[38;2;255;187;0m[4mVisualization[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mParaView[0m[38;5;12m (https://www.paraview.org) - Multi-platform data analysis and visualization application based on VTK.[39m
|
||
[38;5;12m (C++, BSD, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.kitware.com/paraview/paraview))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mVTK[0m[38;5;12m (https://vtk.org/) - Process images and create 3D computer graphics.[39m
|
||
[38;5;12m (C++, BSD, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.kitware.com/vtk/vtk))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mMayavi[0m[38;5;12m (https://docs.enthought.com/mayavi/mayavi/) - 3D scientific data visualization and plotting in Python.[39m
|
||
[38;5;12m (Python, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/enthought/mayavi))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mPolyscope[0m[38;5;12m (https://polyscope.run/) - Viewer and user interface for 3D geometry processing.[39m
|
||
[38;5;12m (C++, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/nmwsharp/polyscope))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mPyVista[0m[38;5;12m (https://docs.pyvista.org/) - 3D plotting and mesh analysis through a streamlined interface for VTK.[39m
|
||
[38;5;12m (Python, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/pyvista/pyvista))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mvedo[0m[38;5;12m (https://vedo.embl.es) - Library for scientific analysis and visualization of 3D objects based on VTK.[39m
|
||
[38;5;12m (Python, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/marcomusy/vedo))[39m
|
||
[38;5;12m- [39m[38;5;14m[1myt[0m[38;5;12m (https://yt-project.org/) - Toolkit for analysis and visualization of volumetric data.[39m
|
||
[38;5;12m (Python, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/yt-project/yt))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mF3D[0m[38;5;12m (https://f3d.app/) - Cross-platform, fast, and minimalist 3D viewer with scientific visualization tools.[39m
|
||
[38;5;12m (C++, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/f3d-app/f3d))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mTTK[0m[38;5;12m (https://topology-tool-kit.github.io/) - Topological data analysis and visualization.[39m
|
||
[38;5;12m (C++/Python, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/topology-tool-kit/ttk))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mmorphologica[0m[38;5;12m (https://github.com/ABRG-Models/morphologica) - Header-only, modern OpenGL code to visualize numerical simulations at runtime. (C++, Apache 2.0, GitHub)[39m
|
||
|
||
[38;2;255;187;0m[4mOther libraries and tools[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mFFTW[0m[38;5;12m (http://www.fftw.org) - Discrete Fourier transforms in one or more dimensions, of arbitrary input size, real and complex.[39m
|
||
[38;5;12m (C, GPL2, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/FFTW/fftw3))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mQhull[0m[38;5;12m (http://www.qhull.org) - Convex hull, Delaunay triangulation, Voronoi diagram, halfspace intersection about a point, etc.[39m
|
||
[38;5;12m (C/C++, [39m[38;5;14m[1mcustom open source license[0m[38;5;12m (http://www.qhull.org/COPYING.txt),[39m
|
||
[38;5;12m [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/qhull/qhull/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mGSL[0m[38;5;12m (https://www.gnu.org/software/gsl/) - Random number generators, special functions, and least-squares fitting etc.[39m
|
||
[38;5;12m (C/C++, GPL 3, [39m[38;5;14m[1mSavannah[0m[38;5;12m (https://savannah.gnu.org/projects/gsl))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mOpenFOAM[0m[38;5;12m (https://www.openfoam.com) - Free, open source CFD (computational fluid dynamics) software.[39m
|
||
[38;5;12m (C++, GPL 3, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/OpenFOAM/OpenFOAM-dev))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mquadpy[0m[38;5;12m (https://github.com/sigma-py/quadpy) - Numerical integration (quadrature, cubature) in Python.[39m
|
||
[38;5;12m (Python, proprietary, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mFiPy[0m[38;5;12m (https://www.ctcms.nist.gov/fipy/) - Finite-volume PDE solver.[39m
|
||
[38;5;12m (Python, [39m[38;5;14m[1mcustom open-source[0m
|
||
[38;5;12m license[39m[38;5;14m[1m (https://www.nist.gov/open/copyright-fair-use-and-licensing-statements-srd-data-software-and-technical-series-publications),[0m
|
||
[38;5;12m [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/usnistgov/fipy))[39m
|
||
[38;5;12m- [39m[38;5;14m[1maccupy[0m[38;5;12m (https://github.com/sigma-py/accupy) - Accurate sums and dot products for Python.[39m
|
||
[38;5;12m (Python, GPL 3, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mSLEPc[0m[38;5;12m (https://slepc.upv.es) - Scalable Library for Eigenvalue Problem Computations.[39m
|
||
[38;5;12m (C, 2-clause BSD, [39m[38;5;14m[1mGitLab[0m[38;5;12m (https://gitlab.com/slepc/slepc))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mChebfun[0m[38;5;12m (https://www.chebfun.org/) - Computing with functions to about 15-digit accuracy.[39m
|
||
[38;5;12m (MATLAB, BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/chebfun/chebfun))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mpyMOR[0m[38;5;12m (https://pymor.org/) - Model Order Reduction with Python.[39m
|
||
[38;5;12m (Python, 2-clause BSD, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/pymor/pymor/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mcvxpy[0m[38;5;12m (https://www.cvxpy.org/) - Modeling language for convex optimization problems.[39m
|
||
[38;5;12m (Python, Apache 2.0, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/cvxpy/cvxpy))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mPyWavelets[0m[38;5;12m (https://pywavelets.readthedocs.io/en/latest/) - Wavelet transforms in Python.[39m
|
||
[38;5;12m (Python, MIT, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/PyWavelets/pywt))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mNFFT[0m[38;5;12m (https://www-user.tu-chemnitz.de/~potts/nfft/) - Nonequispaced fast Fourier transform.[39m
|
||
[38;5;12m (C/MATLAB, GPL 2, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/NFFT/nfft))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mpreCICE[0m[38;5;12m (https://precice.org/) - Coupling library for partitioned multi-physics simulations (FSI, CHT, and more).[39m
|
||
[38;5;12m (C++, LGPL 3, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/precice/))[39m
|
||
[38;5;12m- [39m[38;5;14m[1morthopy[0m[38;5;12m (https://github.com/sigma-py/orthopy) - Compute orthogonal polynomials efficiently.[39m
|
||
[38;5;12m (Python, proprietary, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mpyGAM[0m[38;5;12m (https://pygam.readthedocs.io/en/latest/) - Generalized Additive Models in Python.[39m
|
||
[38;5;12m (Python, Apache 2.0, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/dswah/pyGAM))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mDedalus[0m[38;5;12m (https://dedalus-project.org/) - Solve partial differential equations with spectral methods.[39m
|
||
[38;5;12m (Python, GPL 3, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/DedalusProject/dedalus))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mPyGMO[0m[38;5;12m (https://esa.github.io/pygmo/) - Massively parallel optimization.[39m
|
||
[38;5;12m (Python/C++, MPL 2, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/esa/pygmo2))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mshenfun[0m[38;5;12m (https://shenfun.readthedocs.io/en/latest/) - High-performance Python library for the spectral Galerkin method.[39m
|
||
[38;5;12m (Python, BSD-2, [39m[38;5;14m[1mGitHub[0m[38;5;12m (https://github.com/spectralDNS/shenfun))[39m
|
||
[38;5;12m- [39m[38;5;14m[1mPyDMD[0m[38;5;12m (https://github.com/mathLab/PyDMD) - Dynamic Mode Decomposition (DMD) in Python.[39m
|
||
[38;5;12m (Python, MIT, GitHub)[39m
|
||
[38;5;12m- [39m[38;5;14m[1mHPDDM[0m[38;5;12m (https://github.com/hpddm/hpddm) - High-performance unified framework for domain decomposition methods.[39m
|
||
[38;5;12m (C++, LGPL 3, GitHub)[39m
|
||
|
||
[38;2;255;187;0m[4mCommunity[0m
|
||
|
||
[38;5;12m- [39m[38;5;14m[1mSciComp StackExchange[0m[38;5;12m (https://scicomp.stackexchange.com/) - Computational Science on the StackExchange network.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mWolfgang Bangerth's video class[0m[38;5;12m (https://www.math.colostate.edu/~bangerth/videos.html) - MATH 676: Finite element methods in scientific computing.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mNick Higham's blog[0m[38;5;12m (https://nhigham.com/) - Mostly on MATLAB, general computing advice.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mNick Trefethen's Video Lectures[0m[38;5;12m (https://people.maths.ox.ac.uk/trefethen/videos.html) - 36 video lectures on approximation theory/practice and scientific computing.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mJohn D. Cook's blog[0m[38;5;12m (https://www.johndcook.com/blog/) - Feats of scientific computing.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mJack Dongarra's software list[0m[38;5;12m (https://netlib.org/utk/people/JackDongarra/la-sw.html) - List of freely available software for the solution of linear algebra problems.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mNA Digest[0m[38;5;12m (https://netlib.org/na-digest-html/) - Collection of articles on topics related to numerical analysis and those who practice it.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mGabriel Peyré on Bluesky[0m[38;5;12m (https://bsky.app/profile/gabrielpeyre.bsky.social) - One post a day on computational mathematics.[39m
|
||
[38;5;12m- [39m[38;5;14m[1mDiscord: Numerical Software[0m[38;5;12m (https://discord.com/invite/hnTJ5MRX2Y) - Discord messaging server on numerical software.[39m
|
||
|
||
[38;5;12mscientificcomputing Github: https://github.com/nschloe/awesome-scientific-computing[39m
|