Software Bookmarks
Location: http://people.sc.fsu.edu/~jburkardt/html/software_bookmarks.html
-
AUTO, software by Eusebius Doedel for continuation and bifurcation
problems in ordinary differential equations:
http://indy.cs.concordia.ca/auto/
-
CFD Python, "Twelve Steps to Navier Stokes", a collection of iPython
notebooks by Lorena Barba that teach a beginner how to use Python to
solve a series of increasingly involved problems in computational
fluid dynamics:
http://lorenabarba.com/blog/cfd-python-12-steps-to-navier-stokes/
-
CFD Python, "ME702: Computational Fluid Dynamics",
a set of 28 lectures by Lorena Barba, hosted on YouTube, which
offer the theoretical background for the CFD Python notebooks:
https://www.youtube.com/playlist?list=PL30F4C5ABCE62CB61
-
CMCL: Courant Mathematics and Computing Laboratory Software.
http://www.cims.nyu.edu/cmcl/software.html .
-
MATLAB Cody Coursework,
https://www.mathworks.com/academia/cody-coursework.html .
-
CSPARSE sparse matrix software by Timothy Davis:
http://www.cise.ufl.edu/research/sparse/CSparse
-
CSPARSE videos by Timothy Davis:
http://www.youtube.com/playlist?list=PL5EvFKC69QIyRLFuxWRnH6hIw6e1-bBXB ;
-
DEAL.II, a finite element library, using quadrilaterals in 2D and hexahedrons in 3D:
https://www.dealii.org/ ;
-
DEAL.II videos (and finite elements and more) by Wolfgang Bangerth:
http://www.math.tamu.edu/~bangerth/videos.html ;
-
DIR3, Delaunay Incremental Refinement in 3D, a 3D meshing tool:
http://www.math.cmu.edu/~arand/DIR3/ ;
-
DISLIN, a plotting library:
http://www.mps.mpg.de/dislin/ ;
-
Featflow, a Computational Fluid Dynamics (CFD) Benchmarking Project:
http://www.featflow.de/en/benchmarks.html ;
-
FENICS, a collection of software for the automatic solution of
differential equations using the finite element method:
http://fenicsproject.org/ ;
-
FREEFEM++, a PDE solver for multiphysics nonlinear systems in 2D
and 3D, using the finite element method,
with triangular or tetrahedral elements:
http://www.freefem.org/ ;
-
Globus:
http://www.globus.org,
-
GMSH, a 3D finite element mesh generator:
http://geuz.org/gmsh/ ;
-
GSL, the Gnu Scientific Library:
http://www.gnu.org/software/gsl/ ;
-
GSOC, the Google Summer of Code:
https://developers.google.com/open-source/gsoc/
-
HSL, the Harwell Subroutine Library:
http://www.hsl.rl.ac.uk/ ;
-
IFISS, a MATLAB toolbox for solving Poisson, convection-diffusion,
Stokes, and Navier-Stokes PDE's:
http://www.cs.umd.edu/~elman/ifiss/index.html ;
-
ImageJ, a very useful image manipulation package:
http://rsbweb.nih.gov/ij/ ;
-
Insight, the home page for "Insight Through Computing",
by Charles Van Loan and Daisy Fan,
http://www.cs.cornell.edu/insight ;
-
Intrepid, part of the Trilinos package, a library for
compatible discretization of Partial Differential Equations:
http://trilinos.org/packages/intrepid/ ;
-
Kaggle, the home of data science competitions:
https://www.kaggle.com/ ;
-
LAMMPS, a molecular dynamics code:
http://lammps.sandia.gov/ ;
-
LIBMESH, a library for the numerical simulation of partial
differential equations on arbitrary unstructured meshes
in 1/2/3D with a variety of finite element types:
http://libmesh.sourceforge.net/ ;
-
LIS, a library of linear iterative solvers, with preconditioning,
multiple precision, C/Fortran interface, OpenMP/MPI interface:
http://www.ssisc.org/lis/index.en.html;
-
MEDIT, an OpenGL-based scientific visualization tool, by Pascal Frey:
http://www.ann.jussieu.fr/frey/software.html;
-
MESH2D, Automatic 2D Mesh Generation in MATLAB:
http://www.mathworks.com/matlabcentral/fileexchange/25555-mesh2d-automatic-mesh-generation ;
-
Mesh and grid generation web page of Robert Schneiders:
http://www.robertschneiders.de/meshgeneration/meshgeneration.html ;
-
MeshLab, software for processing and editing unstructured 3D
triangular surface meshes:
http://meshlab.sourceforge.net/ ;
-
MFEM, a scalable C++ library for finite element methods:
http://mfem.org/ ;
-
NaSt3DGP, a parallel 3D flow solver, using finite differences,
from the Michael Griebel group at the University of Bonn:
http://wissrech.iam.uni-bonn.de/research/projects/NaSt3DGP/index.htm ;
-
nbviewer, which can display Jupyter notebooks through a browser:
https://nbviewer.jupyter.org/ ;
-
NetCDF software for dataset storage:
http://www.unidata.ucar.edu/software/netcdf/ ;
-
NETGEN, an automatic 3D mesh generator:
http://www.hpfem.jku.at/netgen/ ;
-
NETLIB:
http://www.netlib.org,
-
Ngram Viewer:
http://ngrams.googlelabs.com ;
-
NS2D, a MATLAB 2D flow solver, using triangular finite elements,
from Jeff Borggaard at Virginia Tech:
http://jborggaard.github.io/ns2d/ ;
-
Octave, a Gnu program that is a numerical computing environment:
https://www.gnu.org/software/octave/ ;
-
OpenACC:
http://www.openacc.org,
-
OpenFOAM, an open source computational fluid dynamics toolbox
for 3D flow including heat transfer, chemical reactions and turbulence:
http://www.openfoam.com ;
-
Paraview, a 3D graphics program:
http://www.paraview.org/ ;
-
Pencil, an easy-to-use drawing code:
http://pencilcode.net/edit/myprogram ;
-
Plot.ly, a system for creating plots online:
https://plot.ly/plot ;
-
PLTMG, (Piecewise Linear Triangle MultiGrid solver for Finite Elements),
by Randolph Bank,
http://ccom.ucsd.edu/~reb/ ;
-
SciLab, a numerical computing environment:
http://www.scilab.org/ ;
-
SciPy, a numerical computing environment:
http://www.scipy.org/ ;
-
Scratch, a programming language.
https://scratch.mit.edu/ ;
-
Slatec, a numerical library:
http://www.netlib.org/slatec/index.html ;
-
SLURM:
https://slurm.schedmd.com/,
-
Socrative:
www.socrative.com ;
-
the SuiteSparse libraries by Timothy Davis of University of Florida:
http://www.cise.ufl.edu/research/sparse/ ;
-
SuperLU, a direct solver for large sparse linear systems of equations,
including sequential, shared memory, and distributed memory versions:
http://crd-legacy.lbl.gov/~xiaoye/SuperLU/ ;
-
TASMANIAN, libraries for high dimensional integration,
interpolation, and calibration, including a sparse grid library:
http://tasmanian.ornl.gov/ ;
-
Tensorflow, an open-source software library for machine intelligence:
https://www.tensorflow.org ;
-
TETGEN, a quality 3D mesh generator and Delaunay triangulator:
http://wias-berlin.de/software/tetgen/ ;
-
TOPCODER, a site that offers coding challenges and cash rewards:
https://www.topcoder.com/ ;
-
Trilinos, an ensemble of
solvers for large scale multi-physics problems:
http://trilinos.sandia.gov/ ;
-
TSPLIB, the traveling salesman problem library:
http://comopt.ifi.uni-heidelberg.de/software/TSPLIB95/ ;
-
VirtualBox allows you to run a "guest operating system".
In particular, a Windows user can set up a Linux environment:
https://www.virtualbox.org/ ;
-
VisIt, visualization tool:
https://wci.llnl.gov/codes/visit/ ;
-
VisItUsers, the VisIt user community web site:
www.visitusers.org/ ;
-
Wolfram demonstrations project:
http://demonstrations.wolfram.com/
-
XSEDE training slides
https://www.psc.edu/index.php/xsede-hpc-series-all-workshops
You can go up one level to
the HTML page.
Last revised on 27 January 2017.