Skip to content

A curated list of repositories related to fluid dynamics.

License

Notifications You must be signed in to change notification settings

thw1021/Code4CFD

Folders and files

NameName
Last commit message
Last commit date

Latest commit

 

History

8 Commits
 
 
 
 

Repository files navigation

A curated list of repositories related to fluid dynamics.

1. Learning Materials

Books

Blogs

Researchers

2. Computational fluid dynamics (CFD)

Solvers

Finite element methods (FEM)

  • JuliaFEM/JuliaFEM.jl: The JuliaFEM software library is a framework that allows for the distributed processing of large Finite Element Models across clusters of computers using simple programming models. It is designed to scale up from single servers to thousands of machines, each offering local computation and storage.
  • FEniCS/dolfinx: Next generation FEniCS problem solving environment
  • deal.II: An open source finite element library
  • firedrakeproject/firedrake: Firedrake is an automated system for the portable solution of partial differential equations using the finite element method (FEM)
  • KratosMultiphysics/Kratos: Kratos Multiphysics (A.K.A Kratos) is a framework for building parallel multi-disciplinary simulation software. Modularity, extensibility and HPC are the main objectives. Kratos has BSD license and is written in C++ with extensive Python interface.
  • feelpp/feelpp: Finite Element Embedded Language and Library in C++
  • FemusPlatform/femus: Multigrid Finite Element Code FEMuS
  • Netgen/NGSolve: High performance multiphysics finite element software
  • ngsxfem/ngsxfem: Add-On to NGSolve for unfitted finite element discretizations
  • PETSc-FEM: A general purpose, parallel, multi-physics FEM (Finite Element Method) program for CFD (Computational Fluid Dynamics) applications based on PETSc
  • Firedrake : Firedrake is an automated system for the solution of partial differential equations using the finite element method
  • FEATFLOW : High performance finite elements
  • ryujin: High-performance second-order collocation-type finite-element scheme for solving the compressible Navier-Stokes and Euler equations of gas dynamics on unstructured meshes
  • gascoigne: a flexible finite element toolkit

Finite volume methods (FVM)

  • OpenFOAM/OpenFOAM-dev: OpenFOAM is a free, open source computational fluid dynamics (CFD) software package released by the OpenFOAM Foundation.
  • su2code/SU2: SU2: An Open-Source Suite for Multiphysics Simulation and Design
  • cselab/aphros: Finite volume solver for incompressible multiphase flows with surface tension
  • code-saturne/code_saturne: code_saturne public mirror
  • FiPy: A Finite Volume PDE Solver Using Python
  • FLUBIO : An unstructured, parallel, finite-volume based Navier-Stokes and convection-diffusion like equations solver for teaching and research purposes

Finite Difference Methods (FDM)

  • pencil-code/pencil-code: A high-order finite-difference code for compressible hydrodynamic flows with magnetic fields and particles
  • roshansamuel/saras: An MPI parallelized Navier-Stokes equation solver written in C++. It uses the finite-difference method for calculating spatial derivatives and parallelized geometric multi-grid method for solving the pressure Poisson equation
  • OpenSBLI: A framework for the automated derivation of finite difference solvers from high-level problem descriptions
  • xcompact3d/Incompact3d: High-order finite-difference flow solvers dedicated to the study of turbulent flows

Spectral methods

  • DedalusProject/dedalus: A flexible framework for solving PDEs with modern spectral methods.
  • FourierFlows/FourierFlows.jl: Tools for building fast, hackable, pseudospectral partial differential equation solvers on periodic domains
  • Nek5000/Nek5000: NEK5000 is an spectral element CFD code developed at the Mathematics and Computer Science Division of Argonne National Laboratory.
  • spectralDNS/shenfun: High performance computational platform in Python for the spectral Galerkin method
  • Semtex: Semtex is a classical quadrilateral spectral element incompressible direct numerical simulation code that uses the standard nodal GLL basis functions to provide two-dimensional solutions and (optionally) Fourier expansions in a homogeneous direction to provide three-dimensional solutions
  • Nek5000/nekRS: Navier Stokes solver based on the spectral element method targeting classical processors and hardware accelerators like GPUs
  • neko: Neko is a portable framework for high-order spectral element flow simulations
  • channelflow: Channelflow is a software system for numerical analysis of the incompressible fluid flow in channel geometries, written in C++ and MPI-parallelized

Smoothed Particle Hydrodynamics (SPH) Methods

  • Xiangyu-Hu/SPHinXsys: It provides C++ APIs for physical accurate simulation and aims to model coupled industrial dynamic systems including fluid, solid, multi-body dynamics and beyond with SPH (smoothed particle hydrodynamics), a meshless computational method using particle discretization
  • DualSPHysics: DualSPHysics is based on the Smoothed Particle Hydrodynamics model named SPHysics (www.sphysics.org). The code is developed (GNU Lesser General Public License) to study free-surface flow phenomena where Eulerian methods can be difficult to apply. DualSPHysics is a set of C++ and CUDA codes designed to deal with real-life engineering problems
  • SPlisHSPlasH: SPlisHSPlasH is an open-source library for the physically-based simulation of fluids. The simulation in this library is based on the Smoothed Particle Hydrodynamics (SPH) method which is a popular meshless Lagrangian approach to simulate complex fluid effects
  • pypr/pysph: A framework for Smoothed Particle Hydrodynamics in Python
  • SPHysics: SPH Free-surface Flow Solver

Lattice Boltzmann methods (LBM)

  • aromanro/LatticeBoltzmann: A 2D Lattice Boltzmann program
  • Palabos: The Palabos library is a framework for general-purpose computational fluid dynamics (CFD), with a kernel based on the lattice Boltzmann (LB) method
  • lbmpy: Run fast fluid simulations based on the lattice Boltzmann method in Python on CPUs and GPUs
  • OpenLB: The OpenLB project provides a C++ package for the implementation of lattice Boltzmann methods that is general enough to address a vast range of tansport problems
  • TCLB: Templated MPI+CUDA/CPU Lattice Boltzmann code
  • hemelb: A high performance parallel lattice-Boltzmann code for large scale fluid flow in complex geometries

Immersed Boundary Methods (IBM)

  • FluSI & Wabbit: Aerodynamics of Insect Flight and Turbulent Flow
  • LESGO: LESGO is a parallel pseudo-spectral large-eddy simulation code
  • notus: It is dedicated to the modelisation and simulation of incompressible fluid flows in a massively parallel context. Its numerical framework is the Finite Volume method on Cartesian staggered grids with a methodological focus on interfaces treatment
  • Lethe: Open-source computational fluid dynamics (CFD) software which uses high-order continuous Galerkin formulations to solve the incompressible Navier–Stokes equations
  • OpenIFEM/OpenIFEM: An implementation of the Immersed Finite Element Method based on deal.II
  • stochasticHydroTools/IBMethod: Immersed Boundary Method
  • Virtual Flow Simulator: The Virtual Flow Simulator (VFS-Geophysics) code is a curvilinear immersed boundary-based model. It includes DNS, K-omega, and LES turbulence models
  • YunchaoYang/NekIBM: A Multiphase flow simulation platform using Direct-forced Immersed Boundary Method based on Spectral element solver Nek5000

Discontinuous Galerkin Methods (DG)

  • exadg/exadg: High-Order Discontinuous Galerkin for the Exa-Scale
  • exapde/Exasim: Generating Discontinuous Galerkin Codes For Extreme Scalable Simulations
  • flexi-framework/flexi: Open Source High-Order Unstructured Discontinuous Galerkin Fluid Dynamics Solver
  • Trixi.jl: Adaptive high-order numerical simulations of hyperbolic PDEs in Julia
  • ChiDG: A Chimera-based, discontinuous Galerkin solver

Other techniques

  • jostbr/shallow-water: Python model solving the shallow water equations (linear momentum, nonlinear continuity)
  • PavelDoGreat/WebGL-Fluid-Simulation: Play with fluids in your browser (works even on mobile)
  • PyFR/PyFR: Framework for solving advection-diffusion type problems on streaming architectures using the Flux Reconstruction approach of Huynh.
  • precice/precice: A coupling library for partitioned multi-physics simulations, including, but not restricted to fluid-structure interaction and conjugate heat transfer simulations.
  • cwrowley/ibpm: Immersed Boundary Projection Method (IBPM)
  • barbagroup/PetIBM: PetIBM - toolbox and applications of the immersed-boundary method on distributed-memory architectures
  • vortexmethods/VM2D: VM2D: Open-Source Code for 2D Flow Simulation by Using Meshless Lagrangian Vortex Methods
  • markstock/vic2d: Two-dimensional semi-Lagrangian vortex method for very low viscosity fluid simulation
  • Cantera/cantera: Chemical kinetics, thermodynamics, and transport tool suite
  • NREL/EnergyPlus: EnergyPlus™ is a whole building energy simulation program that engineers, architects, and researchers use to model both energy consumption and water use in buildings.
  • uDALES/u-dales: uDALES: large-eddy-simulation software for urban flow, dispersion and microclimate modelling
  • taichi-dev/taichi: Parallel programming for everyone.
  • DARcorporation/xfoil-python: Stripped down version of XFOIL as compiled python module
  • mdolab/dafoam: DAFoam: Discrete Adjoint with OpenFOAM for High-fidelity Gradient-based Design Optimization
  • peterdsharpe/AeroSandbox: Aircraft design optimization made fast through modern automatic differentiation. Plug-and-play analysis tools for aerodynamics, propulsion, structures, trajectory design, and much more.
  • team-ocean/veros: The versatile ocean simulator, in pure Python, powered by JAX.
  • CliMA/Oceananigans.jl: software for fast, friendly, flexible, data-driven, ocean-flavored fluid dynamics on CPUs and GPUs
  • gdeskos/DVMpp: 2D Discrete Vortex Method Code written in C++
  • enzo-project/enzo-dev: The Enzo adaptive mesh-refinement simulation code
  • AMReX: A software framework for massively parallel, block-structured adaptive mesh refinement (AMR) applications
  • llnl/samrai: Structured Adaptive Mesh Refinement Application Infrastructure - a scalable C++ framework for block-structured AMR application development
  • ForestClaw: A parallel, adaptive library for logically Cartesian, mapped, multiblock domains
  • Hawkmoth flight simulation: A blade-element model of a hawkmoth (Manduca sexta) implemented as an ODE in MATLAB
  • CFDEM@project: Dedicated to open source high performance scientific computing in fluid mechanics and particle science
  • adamslab-ub/optimizing-bio-inspired-riblets-openfoam: This repository contains key software artifacts of the Open-FOAM based CFD framework that computes the drag coefficient of a NACA-0012 airfoil with bio-inspired surface riblets.
  • andrealani/COOLFluiD: The object-oriented HPC platform for CFD, plasma and multi-physics simulations
  • Fluidity: An open-source computational fluid dynamics code with adaptive unstructured mesh capabilities
  • Basilisk: Basilisk is the solution of partial differential equations on adaptive Cartesian meshes
  • Cantera/cantera: Chemical kinetics, thermodynamics, and transport tool suite
  • code-mphi/ECOGEN: A CFD open source code dedicated to multiphase compressible flows
  • Code_Aster: Structures and Thermomechanics Analysis for Studies and Research
  • GRAL: The initial driver for the development of GRAL was the need for a model that could deal with the frequent low-wind-speed conditions in the inner-Alpine basins of Austria. Another important feature of GRAL is the ability to deal with the dispersion of pollutants emitted from road tunnel portals
  • fluiddyn/fluiddyn: FluidDyn project is an ecosystem of packages for research and teaching in fluid dynamics
  • fluiddyn/fluidsim: Framework for studying fluid dynamics with numerical simulations using Python
  • gismo/gismo: A C++ library for isogeometric analysis
  • HiFiLES: High Fidelity Large Eddy Simulation
  • HiSA: C++ based tool for computing compressible transonic and supersonic flow
  • FLOWUnsteady: A simulation engine of mixed-fidelity unsteady aerodynamics and aeroacoustics
  • REEF3D: An open-source hydrodynamics framework
  • TurbGen: A collection of source code and tools for generating and postprocessing turbulence data
  • HPCWE: High Performance Computing for Wind Energy
  • hyStrath: Featuring hypersonic and rarefied gas dynamics
  • SHARPy: Simulation of High Aspect Ratio aeroplanes and wind turbines in Python, a nonlinear aeroelastic code
  • Kratos: Kratos Multiphysics is a framework for building parallel multi-disciplinary simulation software
  • KVSlab/turtleFSI: Monolithic Fluid-Structure Interaction (FSI) solver
  • libmesh: A framework for the numerical simulation of partial differential equations using arbitrary unstructured discretizations on serial and parallel platforms. A major goal of the library is to provide support for adaptive mesh refinement (AMR) computations in parallel while allowing a research scientist to focus on the physics they are modeling
  • MHYSA: Multispecies Hypersonic Flow Simulator
  • lucasschn/dstoolbox: DSToolbox aims at creating a framework for the analysis of Dynamic Stall based on experimental data. The experimental data might be produced using an airfoil describing different type of motion, especially pitching and ramping up
  • Gerris: Gerris is a Free Software program for the solution of the partial differential equations describing fluid flow
  • matteobernardini/STREAmS: Direct Numerical Simulations of compressible turbulent flows in Cartesian geometry solving the unsteady, fully compressible Navier-Stokes equations for a perfect gas
  • MBDyn: General purpose Multibody Dynamics analysis software
  • mdolab/idwarp: IDWarp uses an inverse distance method to modify the location of mesh volume nodes given a perturbation of the surface nodes
  • MechSys: Library for the implementation of simulation tools in mechanics
  • MFC: MFC is a fully-documented parallel simulation software for multi-component, multi-phase, and bubbly flows
  • MoDeNa-EUProject/MoDeNa: About Software Framework for MOdelling of morphology DEvelopment of micro- and NAnostructures
  • momokhalil/pyHype: Python framework for developing parallelized Computational Fluid Dynamics software to solve the hyperbolic 2D Euler equations on distributed, multi-block structured grids
  • moulin1024/WiRE-LES2: Large-eddy simulation code written in CUDA Fortran for simulating atmospheric boundary layer flows
  • OPM Flow: OPM Flow is a fully-implicit, black-oil simulator capable of running industry-standard simulation models. The simulator is implemented using automatic differentiation to enable rapid development of new fluid models.
  • OuroPablo/Hydro3D: An open source Large Eddy Simulation code
  • PhysicsofFluids/AFiD: A highly parallel application for Rayleigh-Benard and Taylor-Couette flows
  • smdogroup/tacs: parallel finite-element code for analysis and gradient-based design of advanced structures
  • UCNS3D: Unstructured Grids, Compressible Solver, Navier–Stokes 3D
  • vectorfitting: Vector Fitting is a robust numerical method for rational approximation in the frequency domain using poles and residues
  • uDALES/u-dales: Large-eddy-simulation software for urban flow, dispersion and microclimate modelling
  • vvflow/vvflow: CFD software for performing flow simulations with Viscous Vortex Domains (VVD) method
  • weymouth/WaterLily.jl: Fast and simple fluid simulator in Julia
  • YsoSirius/windfarmGA: R Package to Optimize Windfarm Layouts
  • AMReX-Combustion/PeleC: an adaptive-mesh compressible hydrodynamics code for reacting flows
  • openCFS: a finite element-based multi-physics modelling and simulation tool
  • lukasumek/WRF_LES_diagnostics: modification of the WRF model source code (version 4.1) to derive turbulence and mean flow diagnostics
  • CFDEMproject/CFDEMcoupling-PUBLIC: this code provides models and solvers to realize coupled CFD-DEM simulations using LIGGGHTS and OpenFOAM® technology
  • msolids/musen: GPU-accelerated DEM simulation framework
  • quinoacomputing/quinoa: Adaptive computational fluid dynamics
  • p-costa/CaNS: A code for fast, massively-parallel direct numerical simulations (DNS) of canonical flows
  • DNSLABIB: DNSLABIB is a tool for Computational Fluid Dynamics (CFD), implementing the incompressible Navier-Stokes equations with a passive scalar transport equation and Lagrangian particle tracking in MATLAB both on a GPU and CPU
  • OpenHyperFLOW2D: Parallel (C++/MPI/OpenMP/CUDA) research-educational CFD code for simulation 2D (flat/axisymmetrical) transient viscous compressible multicomponent sub/trans/supersonic reacting gas flow with RANS/URANS turbulence models
  • ECOGEN: A CFD open source code dedicated to multiphase compressible flows
  • Mirheo: Mirheo is a GPU high-performance and high-throughput code aimed at simulation of flows at milli- and microscales
  • turtle: TurTLE implements a number of standard functionality of Fourier-based pseudo-spectral numerical simulations, as well as the corresponding numerical particle-tracking functionality
  • pressel/pycles: A python based infrastructure for cloud large eddy simulation
  • mathLab/pi-BEM: Parallel Boundary Element Method solver
  • JULES
  • NGA2: Object-oriented multi-mesh version of the classic reacting turbulent multiphase flow solver.
  • PhasicFlow/phasicFlow: Parallel, highly efficient code (CPU and GPU) for DEM and CFD-DEM simulations.

OpenFOAM Related

  • lesituu: Some libraries (wall model) for OpenFOAM
  • Caelus: Caelus is the next evolution in open-source computational continuum mechanics solutions. Caelus is a derivative of OpenFOAM® but has been restructured to create a stronger foundation on which to build your open-source CFD solutions
  • exaFOAM: The ambitious exaFOAM project aims at overcoming the current limitations of Computational Fluid Dynamics (CFD) technology, especially in what concerns the exploitation of massively parallel HPC architectures.
  • mathLab/ITHACA-FV: Reduced order modelling techniques for OpenFOAM
  • BSL-EARSM: The BSL-EARSM turbulence model of Menter etal (2012) (Menter, F. R., A. V. Garbaruk, and Y. Egorov. "Explicit algebraic Reynolds stress models for anisotropic wall-bounded flows." In Progress in Flight Physics, vol. 3, pp. 89-104. EDP Sciences, 2012.)
  • gmdpapers/hydrothermalfoam: Combination of hydrothermal and OpenFOAM — a three dimensional hydro-thermo-transport model designed to resolvefluid flow within submarine hydrothermal circulation systems
  • OpenQBMM: A suite of solvers to simulate polydisperse multiphase flows using Quadrature-Based Moment Methods (QBMM) based on OpenFOAM
  • olaFlow: olaFlow CFD Suite is a free and open source project committed to bringing the latest advances for the simulation of wave dynamics to the OpenFOAM and FOAM-extend communities
  • OpenFOAM-ShihQuadraticKE: code for ShihQuadraticKE turbulence model
  • Eddylicious : A python library for generating inflow boundary fields for scale-resolving simulations of turbulent flow like LES and DNS
  • Atizar/RapidCFD-dev: RapidCFD is an OpenFOAM fork running fully on CUDA platform
  • zhulianhua/dugksFoam: An OpenFOAM solver for Boltzmann model equation using discrete unified gas kinetic scheme
  • Kiiree/Adaptive-DES-model-2015: Source code for Yin, Zifei, K. R. Reddy, and Paul A. Durbin. "On the dynamic computation of the model constant in delayed detached eddy simulation." Physics of Fluids (1994-present) 27.2 (2015): 025105.
  • TonkomoLLC/chtMultiRegionReactingFoam: OpenFOAM transient solver for buoyant, turbulent fluid flow and solid heat conduction with conjugate heat transfer between solid and fluid regions, plus combustion with chemical reactions
  • ThomasKleiner/tpcMultiRegionFoam: CFD Solver for heat transfer simulations between solid and fluid regions with an implemented model for thermal phase change of pure substances in fluid regions. Algorithm is tested and validated for thin film applications with laminar flow.
  • Spationaute/SuperMarine: Geometry Scipts for blockMesh in OpenFOAM
  • sedfoam/sedfoam: A three-dimensional two-phase flow solver, SedFoam, has been developed for sediment transport applications.
  • asimonder/projectionFoam: The pisoFoam solver to solve incompressible transient flows is iterative. Here it is replaced with an incremental projection scheme which is non-iterative therefore costs less than pisoFoam.
  • precice/openfoam-adapter: OpenFOAM-preCICE adapter
  • parallelwindfarms/cylinder: This package applies parallel-in-time integration, specifically Parareal, to OpenFOAM
  • mtezzele/MORtech-2019-Special-Issue: All the material to reproduce the results of the work titled: "Enhancing CFD predictions in shape design problems by model and parameter space reduction".
  • krebeljk/openInjMoldSim: Open source injection molding simulation. A solver for OpenFOAM.
  • joslorgom/shapeOptimizationFoam: Optimal Shape Design in External Flow with OpenFOAM.
  • joslorgom/heatAdjointFoam: Interior Control of the Heat Equation with the Steepest Descent Method in OpenFOAM.
  • hgopalan/RadianceToFoam: Read the short-wave radiation information from Radiance and use it as a time-varying boundary condition in OpenFOAM.
  • isoAdvector/isoAdvector: a geometric Volume-of-Fluid method for advection of a sharp interface between two incompressible fluids.
  • furstj/myTurbulenceModels: Additional turbulence models for OpenFOAM
  • Franjcf/hybridPorousInterFoam: OpenFOAM solver for performing single- and two-phase flow simulations on hybrid-scale porous media.
  • davidsblom/FOAM-FSI: Fluid-Structure Interaction solvers for foam-extend
  • chenxijun1029/idugksFoam: An OpenFOAM solver for incompressible isothermal fluid.
  • BlenderFOAM: Open-source Fluid Based Shape Optimization
  • BjarkeEltardLarsen/stabRAS_OF50: This repository contains formally stabilized versions of standard two-equation turbulence models for OpenFOAM-5.0
  • Rdfing/TurbulenceModel: Some turbulence models used in OpenFOAM
  • classy_blocks: Python classes for easier creation of openFoam's blockMesh dictionaries.
  • blastfoam: A CFD solver for multi-component compressible flow with application to high-explosive detonation, explosive safety and air blast.
Learn OpenFOAM

GPU

  • Fiesta: FIESTA (Fast InterfacES and Transition in the Atmosphere) is a GPU accelerated, exascale ready computational fluid dynamics code. FIESTA is designed to solve compressible flow problems with gas interfaces at a range of physical scales.
  • HTR-solver: Hypersonic Task-based Research (HTR) solver for the Navier-Stokes equations at hypersonic Mach numbers including finite-rate chemistry for dissociating air and multicomponent transport.
  • maxcuda/CaNS: A code for fast, massively-parallel direct numerical simulations (DNS) of canonical flows
  • Nek5000/nekRS: Navier Stokes solver based on the spectral element method targeting classical processors and hardware accelerators like GPUs
  • AFiD_GPU_opensource: Version of the AFiD code ported to GPU accelerators

Rotor

  • dust: a flexible solution for aerodynamic simulation of complex configurations

Machine learning / Deep Learning

Super-resolution

  • Jianxun-Wang/PICNNSR: About Super-resolution and denoising of fluid flow using physics-informed convolutional neural networks without high-resolution labels -- parametric forward SR and boundary inference

Uncertainty Quantification

  • DAKOTA: The Dakota project delivers both state-of-the-art research and robust, usable software for optimization and UQ
  • multiUQ: Multiphase flow solver with uncertainty quantification
  • KTH-Nek5000/UQit: A Python Package for Uncertainty Quantification (UQ) in Computational Fluid Dynamics
  • SURGroup/UQpy: UQpy (Uncertainty Quantification with python) is a general purpose Python toolbox for modeling uncertainty in physical and mathematical systems.

Optimization

  • OpenMDAO: OpenMDAO is an open-source high-performance computing platform for systems analysis and multidisciplinary optimization, written in Python

Platforms

  • kokkos: Kokkos C++ Performance Portability Programming EcoSystem: The Programming Model - Parallel Execution and Memory Abstraction

4. Tools

  • mathLab/PyDMD: Python Dynamic Mode Decomposition
  • dynamicslab/pysindy: A sparse regression package with several implementations for the Sparse Identification of Nonlinear Dynamical systems.
  • ritchieng/eigenvectors-from-eigenvalues: This repository implements a calculation of eigenvectors from eigenvectors elegantly through PyTorch.
  • mengaldo/PySPOD: A Python package for spectral proper orthogonal decomposition (SPOD).
  • belson17/modred: An easy-to-use and parallelized library for finding modal decompositions and reduced-order models.
  • Astroua/TurbuStat: Statistics of Turbulence Python Package.
  • haller-group/LCStool: LCStool: LCS Tool is a computational engine for analyzing fluid flows by extracting their most influential material surfaces, Lagrangian Coherent Structures.
  • mauritssilvis/lesTools: A toolbox for the construction and assessment of subgrid-scale models for large-eddy simulations
  • AtzoriMarco/InSituPackage: In-Situ analysis for Nek5000 (v17) and Catalyst
  • GIBBON: IBBON (The Geometry and Image-Based Bioengineering add-On) is an open-source MATLAB toolbox by Kevin M. Moerman and includes an array of image and geometry visualization and processing tools and is interfaced with free open source software such as TetGen, for robust tetrahedral meshing, and FEBio for finite element analysis
  • fluiddyn/fluidfoam: OpenFoam postprocessing python tool
  • inendi/inspector: INENDI Inspector allows any user to perform interactive explorations over very large amounts of data.
  • redbKIT: A MATLAB library for reduced-order modeling of PDEs.

6. Datasets

8. Related links

About

A curated list of repositories related to fluid dynamics.

Resources

License

Stars

Watchers

Forks

Releases

No releases published

Packages

No packages published