This is an auto generated comparison from manually filled `*.profiles` for FEA software. It is also available in HTML format preview 1 (fast and correct rendering of html table from previous commit), preview 2 (a bit slow, had problems with Firefox, usually current commit) with first row and Feature column being fixed for ease of table exploration. Profiles in table are sorted with the number of filled keys.
Profile is read line-by-line. Any string before colon ‘:’ is treated as a key, the other part till the end of the line as value. Lines without colon are ignored, comments should start with hash ‘#’ in the begging of the line. main-keys.txt file contains keys in order to be listed first, all other keys from all profiles are lister afterwards. Key are always carried with colon, table group names are not (for visual ease they are four spaces indented). Use generate-comparison.py to generate a table from profiles, you will need to install `org-ruby` gem to convert it into HTML format (use `sudo gem install org-ruby` in Ubuntu linux to install this gem).
Fill free to contribute! There is still a lot of codes, not compared it the table, e.g: MFEM, NgSolve, CalculiX and Salomé + Code_Saturne, ANSYS, NASTRAN, CFD-ACE+, COSMOSWORKS. Comsol(R) description is poor.
Feature | code_aster | GetFEM++ | Deal II | Range | Elmerfem | MOOSE | libMesh | FEniCS | FEATool Multiphysics | Firedrake | COMSOL(R) |
---|---|---|---|---|---|---|---|---|---|---|---|
website: | https://www.code-aster.org | http://home.gna.org/getfem/ | http://www.dealii.org | http://www.range-software.com | https://www.csc.fi/elmer | https://www.mooseframework.org/ | http://libmesh.github.io/ | http://fenicsproject.org/ | https://www.featool.com/ | http://firedrakeproject.org/ | https://www.comsol.com |
license: | GPL | LGPL | LGPL | GPL | GNU (L)GPL | LGPL | LGPL | GNU GPL\LGPL | Proprietary | GNU LGPL | Proprietary |
GUI: | Yes (Salome-Meca) | No | No | Yes | Yes, partial functionality | Yes | No | Postprocessing only | Matlab and Octave GUI | No | Yes |
Community: | discussion forum, Bitbucket forge | Mailing list | Google Group | GitHub | 1000’s of users, discussion forum, mailing list Discord server | Google Group | mail lists | Mailing list | Mailing list | Mailing list and IRC channel | |
Documentation: | user manual, theory manual, verification manual, developer manual (more than 25000 pages both in French and English with machine translation) | User doc, tutorials, demos, developer’s guide | 50+ tutorials, 50+ video lectures, Doxygen | user manual, tutorials | ElmerSolver Manual, Elmer Models Manual, ElmerGUI Tutorials, etc. (>700 pages of LaTeX documentation) | Doxygen, Markdown, 170+ example codes, 4300+ test inputs | Doxygen, 100+ example codes | Tutorial, demos (how many?), 700-page book | Online FEATool documentation, ~600 pages, ~20 step-by-step tutorials, and 85 m-script model examples | Manual, demos, API reference | |
Mesh | |||||||||||
mesh elements: | segments (1d), triangles, quadrilaterals (2d), tetrahedra, pyramids, wedges, hexahedra (3d) | intervals, triangles, tetrahedra, quads, hexes, prisms, some 4D elements, easily extensible. | intervals (1d), quads (2d), and hexes (3d) only | points(0d), segments (1d), triangles, quadrilaterals (2d), tetrahedra, hexahedra (3d) | intervals (1d), triangles, quadrilaterals (2d), tetrahedra, pyramids, wedges, hexahedra (3d) | Tria, Quad, Tetra, Prism, etc. | Tria, Quad, Tetra, Prism, etc. | intervals, triangles, tetrahedra (quads, hexes - work in progress) | intervals, triangles, tetrahedra, quads, hexes | intervals, triangles, tetrahedra, quads, plus extruded meshes of hexes and wedges | |
mesh high-order mapping: | Quadratic | any order | Yes, for Lagrange elements | (Any - work in progress) | (Any - using appropriate branches) | Any? Second-order is the default for most cases. | |||||
mesh generation: | Yes (Salome-Meca) | Experimental in any dimension + predefined shapes + Extrusion. | external+predefined shapes | Yes (TetGen) | Limited own meshing capabilities with ElmerGrid and netgen/tetgen APIs. Internal extrusion and mesh multiplication on parallel level. | Built-in | Built-in | Yes, Constructive Solid Geometry (CSG) supported via mshr (CGAL and Tetgen used as backends) | Integrated DistMesh, Gmsh, and Triangle GUI and CLI interfaces | External + predefined shapes. Internal mesh extrusion operation. | Built-in |
mesh adaptive-refinement: | h-refinement | Only h | h, p, and hp for CG and DG | h-refinement for selected equations | h, p, mached hp, singular hp | h, p, mached hp, singular hp | Only h | generate new mesh with variable density, no(?) p-refinement. | |||
mesh input\output: | unv, gmsh, MED, aster | gmsh, GiD, Ansys | rbm, stl | ExodusII, Nemesis, Abaqus, Ensight, Gmsh, GMV, OFF, TecPlot TetGen, etc. | ExodusII, Nemesis, Abaqus, Ensight, Gmsh, GMV, OFF, TecPlot TetGen, etc. | XDMF (and FEniCS XML) | FeatFlow, FEniCS XML, GiD, Gmsh, GMV, Triangle | ||||
mesh check: | limited features (double nodes, degenerated elements) | ? | limited features (double nodes, degenerated elements, intersected elements) | intersections (collision testing) | |||||||
CAD files support: | Yes (Salome-Meca) | No | IGES, STEP (with OpenCascade wrapper) | Yes (stl) | Limited support via OpenCASCADE in ElmerGUI | STEP, IGES and many others. | |||||
mesh operation: | Yes (Salome-Meca) | Extrude, rotate, translation, refine | Extrude, rotate, translation, refine | Merge, join, extrude, modular mesh modifier system | distort/translate/rotate/scale | Merge, join, extrude, and revolve operations | |||||
Parallel possibilities | |||||||||||
automatic mesh partitioning: | Yes for parallel calculations (PTScotch, ParMetis) | Yes (METIS) | yes, shared (METIS/Parmetis) and distributed (p4est) | No | partitioning with ElmerGrid using Metis or geometric division | Metis, Parmetis, Hilbert (shared and distributed meshes) | Metis, Parmetis, Hilbert | Yes (ParMETIS and SCOTCH) | Yes | ||
MPI: | Yes | Yes | Yes (up to 147k processes), test for 4k processes and geometric multigrid for 147k, strong and weak scaling | No | Yes, demonstrated scalability up to 1000’s of cores | Yes | Yes | Yes, DOLFIN solver scales up to 24k | Yes, Scaling plot for Firedrake out to 24k cores. | Almost ideal for parameter sweep? For large scale simulations Comsol 4.2 bench by Pepper has 19.2 speedup on 24 core cluster (0.8 efficiency). | |
threads: | Yes | Threading Build Blocks | Yes | threadsafe, limited threading, work in progress | Yes | Yes | |||||
OpenMP: | Yes | Yes | Yes (vectorization only) | Yes | Yes, partially | Yes | Yes | Limited | |||
OpenCL: | No | No | No | No | No | ||||||
CUDA: | No | No | since 9.1, see step-64 for matrix-free GPU+MPI example | No | No | ||||||
Solver | |||||||||||
Dimension: | 0D/1D/2D/3D (dimensions may coexist) | Any, possibility to mix and couple problem of different dimension | 1/2/3D | 0D/1D/2D/3D (dimensions may coexist) | 1D/2D/3D (dimensions may coexist) | 1/2/3D | 2D\3D | 1/2/3D | 1/2/3D | 1/2/3D | |
FE: | Lagrange elements (isoparametric), mixed elements, structural mechanics elements (beam, plate) | Continuous and discontinuous Lagrange, Hermite, Argyris, Morley, Nedelec, Raviart-Thomas, composite elements (HCT, FVS), Hierarchical elements, Xfem, easily extensible. | Lagrange elements of any order, continuous and discontinuous; Nedelec and Raviart-Thomas elements of any order; BDM and Bernstein; elements composed of other elements. | Lagrange elements | Lagrange elements, p-elements up to 10th order, Hcurl conforming elements (linear and quadratic) for | Lagrange, Hierarchic, Discontinuous Monomials, Nedelec | Lagrange, Hierarchic, Discontinuous Monomials, Nedelec | Lagrange, BDM, RT, Nedelic, Crouzeix-Raviart, all simplex elements in the Periodic Table (femtable.org), any | Lagrange (1st-5th order), Crouzeix-Raviart, Hermite | Lagrange, BDM, RT, Nedelec, all simplex elements and Q- quad elements in the Periodic Table, any | in Wave Optics Module: frequency domain and trainsient UI - 1,2, and 3 order; time explicit UI - 1,2,3, and 4 order; |
Quadrature: | depending on the type of element (Gauss, Newton-Cotes, etc) | Gauss-Legendre, Gauss-Lobatto, midpoint, trapezoidal, Simpson, Milne and Weddle (closed Newton-Cotes for 4 and 7 order polinomials), Gauss quadrature with logarithmic or 1/R weighting function, Telles quadrature of arbitrary order. | Gauss-Legendre (1D and tensor product rules in 2D and 3D) tabulated up to 44th-order to high precision, best available rules for triangles and tetrahedra to very high order, best available monomial rules for quadrilaterals and hexahedra. | Gauss-Legendre (1D and tensor product rules in 2D and 3D) tabulated up to 44th-order to high precision, best available rules for triangles and tetrahedra to very high order, best available monomial rules for quadrilaterals and hexahedra. | |||||||
Transient problems: | Yes | Any user implemented and/or from a set of predifined. Explicit methods: forward Euler, 3rd and 4th order Runge-Kutta. Implicit methods: backward Euler, implicit Midpoint, Crank-Nicolson, SDIRK. Embedded explicit methods: Heun-Euler, Bogacki-Shampine, Dopri, Fehlberg, Cash-Karp. | Yes | implicit-euler explicit-euler crank-nicolson bdf2 explicit-midpoint dirk explicit-tvd-rk-2 newmark-beta | BE, CN, and Fractional-Step-Theta schemes | (?) assume 2nd order leapfrog for wave optics? | |||||
Predifined equations: | Yes (mechanics, thermics, acoustics) | Laplace? | Yes (Incompressible Navier-Stokes, Heat transfer (convection-conduction-radiation), Stress analysis, Soft body dynamics, Modal analysis, Electrostatics, Magnetostatics ) | Around 40 predefined solvers | Phase Field, Solid Mechanics, Navier-Stokes, Porous Flow, Level Set, Chemical Reactions, Heat Conduction, support for custom PDEs | No | Incompressible Navier-Stokes, Heat transfer, convection-diffusion-reaction, linear elasticity, electromagnetics, Darcy’s, Brinkman equations, and support for custom PDE equations | Yes, via modules | |||
Automated assembly: | Yes | Yes | Yes | Yes | Yes | Yes | |||||
Visualization: | Paraview (Salome-Meca) | External or with the Scilab/Matlab/Python interface. Possibility to perform complex slices. | External (export to *.vtk and many others) | GUI (built-in) | ElmerPost, VTK widget (but Paraview is recommended) | Yes, VTK-based GUI, Python visualizatuion library | No | Buil-in simple plotting + External | Built-in with optional Plotly and GMV export | External | Built-in |
Output format: | MED, ASCII | vtk, gmsh, OpenDX. | *.dx *.ucd *.gnuplot *.povray *.eps *.gmv *.tecplot *.tecplot_binary *.vtk *.vtu *.svg *.hdf5 | Several output formats (VTU, gmsh,…) | ExodusII, Xdr, etc. | ExodusII, Xdr, etc. | VTK(.pvd, .vtu) and XDMF/HDF5 | GMV and Plotly | VTK(.pvd, .vtu) | ||
Boundary elements solver: | Yes for Soil-Structure Interaction (Miss3D) | No | Yes | Existing but without multipole acceleration (not usable for large problems) | No | No | |||||
Use multiple meshes: | Yes | Yes including different dimensions and taking account of any transformation. | Yes, autorefined from same initial mesh for each variable of a coupled problem | Continuity of non-conforming interfaces ensured by mortar finite elements | Yes, including non-matching meshes | Yes | |||||
Linear algebra | |||||||||||
Used libs: | BLAS/LAPACK, MUMPS (and SCALAPACK), PETSc | SuperLU, MUMPS, Built-in. | Built-in + Trilinos, PETSc, and SLEPc | No | Built-in, Hypre, Trilinos, umfpack, MUMPS, Pardiso, etc. (optional) | PETSc, Trilinos, LASPack, SLEPc | PETSc, Trilinos, LASPack, SLEPc | PETSc, Trilinos/TPetra, Eigen. | Matlab/Octave built-in (Umfpack), supports integration with the FEniCS and FeatFlow solvers | PETSc | |
Iterative matrix solvers: | GMRES, CG, GCR, CR, FGMRES (via PETSc) | All Krylov | All Krylov (CG, Minres, GMRES, BiCGStab, QMRS) | GMRES, CG | Built-in Krylov solvers, Krylov and multigrid solvers from external libraries | LASPack serial, PETSc parallel | LASPack serial, PETSc parallel | Matlab/Octave built-in | |||
Preconditioners: | ILU, Jacobi, Simple Precision Preconditioner (via MUMPS) | Basic ones (ILU, ILUT) | Many, including algebraic multigrid (via Hypre and ML) and geometric multigrid | ILU, Jacobi | Built-in preconditioners (ILU, diagonal, vanka, block) and | LASPack serial, PETSc parallel, algebraic multigrid (via Hypre) | LASPack serial, PETSc parallel | Matlab/Octave built-in | |||
Matrix-free | |||||||||||
matrix-free: | No | No | Yes | No | Experimental implementation | Yes | |||||
matrix-free save memory: | No | No | Yes | No | |||||||
matrix-free speed-up: | No | No | Yes | No | |||||||
Used language | |||||||||||
Native language: | Fortran 90, Python | C++ | C++ | C++ | Fortran (2003 standard) | C++ | C++ | C++ | Matlab / Octave | Python (and generated C) | |
Bindings to language: | Python | Python, Scilab or Matlab | No | No | Python | ||||||
Other | |||||||||||
Predefined equations: | linear quasistatics, linear thermics, non-linear quasistatics, non-linear dynamics, eigen problem for mechanics, linear dynamics on physical basis and modal basis, harmonic analysis, spectral analysis | Model bricks: Laplace, linear and nonlinear elasticity, Helmholtz, plasticity, Mindlin and K.L. plates, boundary conditions including contact with friction. | |||||||||
Coupled nonlinear problems: | thermo-hydro-mechanical problem for porous media, coupling with Code_Saturne CFD software for Fluid-Structure Interaction via SALOME platform | Yes | |||||||||
Binary: | Yes for Salome-Meca (Linux) | Linux (Debian/Ubuntu) | Linux, Windows (work in progress), Mac | Windows, Linux (launchpad: Debian/Ubuntu), Mac (homebrew) (all with MPI) | Linux (Debian\Ubuntu), Mac | Windows, Linux, Mac | No. Automated installers for Linux and Mac | ||||
fullname: | Analyse des Structures et Thermo-mécanique pour des Études et des Recherches (ASTER) | Elmer finite element software | |||||||||
Testing: | More than 3500 verification testcases covering all features and providing easy starting points for beginners | 3500+ tests | More than 400 consistency tests ensuring backward compatibility | 4300+ tests, Testing as a service for derived applications | |||||||
Symbolic derivation of the tangent system for nonlinear problems: | Yes | ||||||||||
Support for fictitious domain methods: | Yes | ||||||||||
Wilkinson Prize: | 2007 | 2015 for dolfin-adjoint | |||||||||
scripting: | Runtime parsed mathematical expression in input files | Fully scriptable in as m-file Matlab scripts and the GUI supports exporting models in script format | |||||||||
automatic differentiation: | Forward-mode for Jacobian computation, symbolic differentiation capabilities | ||||||||||
multiphysics: | Arbitrary multiphysics couplings are supported | Arbitrary multiphysics couplings are supported | |||||||||
Optimization Solvers: | Support for TAO- and nlopt-based constrained optimization solvers incorporating gradient and Hessian information. | Support for TAO- and nlopt-based constrained optimization solvers incorporating gradient and Hessian information. |