The current version of PETSc is 3.8; released September 26, 2017.
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, and GPUs through CUDA or OpenCL, as well as hybrid MPI-GPU parallelism. PETSc (sometimes called PETSc/Tao) also contains the Tao optimization software library.
- 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
- PermonSVM support vector machines and PermonQP quadratic programming
- MOOSE - Multiphysics Object-Oriented Simulation Environment finite element framework, built on top of libMesh and PETSc
- SLEPc - Scalable Library for Eigenvalue Problems
- COOLFluiD - CFD, plasma and multi-physics simulation package
- Fluidity - a finite element/volume fluids code
- OpenFVM - finite volume based CFD solver
- OOFEM - object oriented finite element library
- libMesh - adaptive finite element library
- FEniCS - sophisticated Python based finite element simulation package
- Firedrake - sophisticated Python based finite element simulation package
- DEAL.II - sophisticated C++ based finite element simulation package
- PHAML - The Parallel Hierarchical Adaptive MultiLevel Project
- Chaste - Cancer, Heart and Soft Tissue Environment
- PyClaw - A massively parallel, high order accurate, hyperbolic PDE solver
- PetIGA - A framework for high performance Isogeometric Analysis
- MFEM - lightweight, scalable C++ library for finite element methods
-
Python Bindings
Java Bindings
- jpetsctao from Hannes Sommer (this does not appear to be functional any longer
- Packages that PETSc can optionally use