The current version of PETSc is 3.3; released June 5, 2012.
PETSc, pronounced PET-see (the S is silent), is a suite of data structures and routines for the scalable (parallel) solution of scientific applications modeled by partial differential equations. It supports MPI, shared memory pthreads, and NVIDIA GPUs, as well as hybrid MPI-shared memory pthreads or MPI-GPU parallelism.
- Scientific applications that use PETSc
- Features of the PETSc libraries (and a recent podcast)
- Linear system solvers accessible from PETSc
-
Related packages that use PETSc
- TAO - Toolkit for Advanced Optimization
- SLEPc - Scalable Library for Eigenvalue Problems
- fluidity - a finite element/volume fluids code
- Prometheus - scalable unstructured finite element solver
- freeCFD - general purpose CFD solver
- OpenFVM - finite volume based CFD solver
- OOFEM - object oriented finite element library
- libMesh - adaptive finite element library
- DEAL.II - sophisticated C++ based finite element simulation package
- PHMAL - The Parallel Hierarchical Adaptive MultiLevel Project
- Chaste - Cancer, Heart and Soft Tissue Environment
-
Python Bindings
Java Bindings
- jpetsctaoHannes Sommer
- Packages that PETSc can optionally use