Featurecode_asterGetFEM++Deal IIElmerfemRangeFEniCSFEATool MultiphysicsFiredrakelibMeshCOMSOL(R)
website:https://www.code-aster.orghttp://home.gna.org/getfem/http://www.dealii.orghttps://www.csc.fi/elmerhttp://www.range-software.comhttp://fenicsproject.org/https://www.featool.com/http://firedrakeproject.org/http://libmesh.github.io/https://www.comsol.com
license:GPLLGPLLGPLGNU (L)GPLGPLGNU GPL\LGPLProprietaryGNU LGPLGPLProprietary
GUI:Yes (Salome-Meca)NoNoYes, partial functionalityYesPostprocessing onlyMatlab and Octave GUINoNoYes
Community:discussion forum, Bitbucket forgeMailing listGoogle Group1000’s of users, discussion forum, mailing listGitHubMailing listMailing listMailing list and IRC channelmail lists
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 guide50+ tutorials, 50+ video lectures, DoxygenElmerSolver Manual, Elmer Models Manual, ElmerGUI Tutorials, etc. (>700 pages of LaTeX documentation)user manual, tutorialsTutorial, demos (how many?), 700-page bookOnline FEATool documentation, ~600 pages, ~20 step-by-step tutorials, and 85 m-script model examplesManual, demos, API referenceDoxygen, 40+ example codes
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) onlyintervals (1d), triangles, quadrilaterals (2d), tetrahedra, pyramids, wedges, hexahedra (3d)points(0d), segments (1d), triangles, quadrilaterals (2d), tetrahedra, hexahedra (3d)intervals, triangles, tetrahedra (quads, hexes - work in progress)intervals, triangles, tetrahedra, quads, hexesintervals, triangles, tetrahedra, quads, plus extruded meshes of hexes and wedgesTria, Quad, Tetra, Prism, etc.
mesh high-order mapping:Quadraticany orderYes, 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 shapesLimited own meshing capabilities with ElmerGrid and netgen/tetgen APIs. Internal extrusion and mesh multiplication on parallel level.Yes (TetGen)Yes, Constructive Solid Geometry (CSG) supported via mshr (CGAL and Tetgen used as backends)Integrated DistMesh, Gmsh, and Triangle GUI and CLI interfacesExternal + predefined shapes. Internal mesh extrusion operation.Built-inBuilt-in
mesh adaptive-refinement:h-refinementOnly hh, p, and hp for CG and DGh-refinement for selected equationsOnly hh, p, mached hp, singular hpgenerate new mesh with variable density, no(?) p-refinement.
mesh input\output:unv, gmsh, MED, astergmsh, GiD, Ansysrbm, stlXDMF (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)NoIGES, STEP (with OpenCascade wrapper)Limited support via OpenCASCADE in ElmerGUIYes (stl)STEP, IGES and many others.
mesh operation:Yes (Salome-Meca)Extrude, rotate, translation, refineExtrude, rotate, translation, refineMerge, join, extrude, and revolve operationsdistort/translate/rotate/scale
Parallel possibilities
automatic mesh partitioning:Yes for parallel calculations (PTScotch, ParMetis)Yes (METIS)yes, shared (METIS/Parmetis) and distributed (p4est)partitioning with ElmerGrid using Metis or geometric divisionNoYes (ParMETIS and SCOTCH)Yes
MPI:YesYesYes (up to 147k processes), test for 4k processes and geometric multigrid for 147k, strong and weak scalingYes, demonstrated scalability up to 1000’s of coresNoYes, DOLFIN solver scales up to 24kYes, Scaling plot for Firedrake out to 24k cores.YesAlmost 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:YesThreading Build Blocksthreadsafe, limited threading, work in progressYesYes
OpenMP:YesYesYes (vectorization only)Yes, partiallyYesLimited
OpenCL:NoNoNoNoNo
CUDA:NoNowork in progressNoNo
Solver
Dimension:0D/1D/2D/3D (dimensions may coexist)Any, possibility to mix and couple problem of different dimension1/2/3D1D/2D/3D (dimensions may coexist)0D/1D/2D/3D (dimensions may coexist)1/2/3D1/2/3D1/2/3D2D\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, p-elements up to 10th order, Hcurl conforming elements (linear and quadratic) forLagrange elementsLagrange, BDM, RT, Nedelic, Crouzeix-Raviart, all simplex elements in the Periodic Table (femtable.org), anyLagrange (1st-5th order), Crouzeix-Raviart, HermiteLagrange, BDM, RT, Nedelec, all simplex elements and Q- quad elements in the Periodic Table, anyLagrange, Hierarchic, Discontinuous Monomialsin 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.
Transient problems:YesAny 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.YesBE, CN, and Fractional-Step-Theta schemes(?) assume 2nd order leapfrog for wave optics?
Predifined equations:Yes (mechanics, thermics, acoustics)Laplace?Around 40 predefined solversYes (Incompressible Navier-Stokes, Heat transfer (convection-conduction-radiation), Stress analysis, Soft body dynamics, Modal analysis, Electrostatics, Magnetostatics )Incompressible Navier-Stokes, Heat transfer, convection-diffusion-reaction, linear elasticity, electromagnetics, Darcy’s, Brinkman equations, and support for custom PDE equationsNoYes, via modules
Automated assembly:YesYesYesYesYesYes
Visualization:Paraview (Salome-Meca)External or with the Scilab/Matlab/Python interface. Possibility to perform complex slices.External (export to *.vtk and many others)ElmerPost, VTK widget (but Paraview is recommended)GUI (built-in)Buil-in simple plotting + ExternalBuilt-in with optional Plotly and GMV exportExternalNoBuilt-in
Output format:MED, ASCIIvtk, gmsh, OpenDX.*.dx *.ucd *.gnuplot *.povray *.eps *.gmv *.tecplot *.tecplot_binary *.vtk *.vtu *.svg *.hdf5Several output formats (VTU, gmsh,…)VTK(.pvd, .vtu) and XDMF/HDF5GMV and PlotlyVTK(.pvd, .vtu)
Boundary elements solver:Yes for Soil-Structure Interaction (Miss3D)NoYesExisting but without multipole acceleration (not usable for large problems)NoNo
Use multiple meshes:YesYes including different dimensions and taking account of any transformation.Yes, autorefined from same initial mesh for each variable of a coupled problemContinuity of non-conforming interfaces ensured by mortar finite elementsYes, including non-matching meshesYes
Linear algebra
Used libs:BLAS/LAPACK, MUMPS (and SCALAPACK), PETScSuperLU, MUMPS, Built-in.Built-in + Trilinos, PETSc, and SLEPcBuilt-in, Hypre, Trilinos, umfpack, MUMPS, Pardiso, etc. (optional)NoPETSc, Trilinos/TPetra, Eigen.Matlab/Octave built-in (Umfpack), supports integration with the FEniCS and FeatFlow solversPETScPETSc, Trilinos, LASPack, SLEPc
Iterative matrix solvers:GMRES, CG, GCR, CR, FGMRES (via PETSc)All KrylovAll Krylov (CG, Minres, GMRES, BiCGStab, QMRS)Built-in Krylov solvers, Krylov and multigrid solvers from external librariesGMRES, CGMatlab/Octave built-inLASPack serial, PETSc parallel
Preconditioners:ILU, Jacobi, Simple Precision Preconditioner (via MUMPS)Basic ones (ILU, ILUT)Many, including algebraic multigrid (via Hypre and ML) and geometric multigridBuilt-in preconditioners (ILU, diagonal, vanka, block) andILU, JacobiMatlab/Octave built-inLASPack serial, PETSc parallel
Matrix-free
matrix-free:NoNoYesExperimental implementationNoYes
matrix-free save memory:NoNoYesNo
matrix-free speed-up:NoNoYesNo
Used language
Native language:Fortran 90, PythonC++C++Fortran (2003 standard)C++C++Matlab / OctavePython (and generated C)C++
Bindings to language:PythonPython, Scilab or MatlabNoNoPython
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 analysisModel 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 platformYes
Binary:Yes for Salome-Meca (Linux)Linux (Debian/Ubuntu)Linux, Windows (work in progress), MacWindows, Linux (launchpad: Debian/Ubuntu), Mac (homebrew) (all with MPI)Linux (Debian\Ubuntu), MacWindows, Linux, MacNo. 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 beginners3500+ testsMore than 400 consistency tests ensuring backward compatibility
Symbolic derivation of the tangent system for nonlinear problems:Yes
Support for fictitious domain methods:Yes
Wilkinson Prize:20072015 for dolfin-adjoint
scripting:Fully scriptable in as m-file Matlab scripts and the GUI supports exporting models in script format
multiphysics:Arbitrary multiphysics couplings are supported
Optimization Solvers:Support for TAO- and nlopt-based constrained optimization solvers incorporating gradient and Hessian information.

Overview

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 format

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).

Contribution

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.