finite-volume

There are 97 repositories under finite-volume topic.

  • 12-Steps-to-Navier-Stokes

    CFD Python, a.k.a. the 12 steps to Navier-Stokes taught by Prof. Lorena Barba

    Language:Python25
  • phd

    The working repository for my PhD project at the Centre for Scientific Computing, Cambridge

    Language:C++24
  • TinyFluid

    FV based Navier-Stokes / Transport Equation / Conservation Law Solver for Procedural World Simulation. Designed for CFD learning purposes.

    Language:C++23
  • finitevolume2-python

    Create Your Own Finite Volume Fluid Simulation (With Python) Part 2: Boundary Conditions and Source Terms

    Language:Python21
  • KiT-RT

    KiT-RT

    A high performance framework for radiation therapy simulation and numerical solutions for kinetic equations.

    Language:C++21
  • Development-of-Navier-Stokes-code-by-projection-method

    This repository contains a Fortran implementation of a 2D flow using the projection method, with Finite Volume Method (FVM) approach. The code solves Navier Stokes equations in a 2D lid driven cavity, with computation of the rotational as well.

    Language:Fortran20
  • constrainedtransport-python

    Finite Volume Constrained Transport MHD simulation of the Orszag-Tang vortex

    Language:Python16
  • AdditiveFOAM

    Software to simulate heat transfer and fluid flow in additive manufacturing using OpenFOAM

    Language:C++16
  • Havoc

    Hydrodynamics on a moving Voronoi mesh.

    Language:C++14
  • ESVM

    Finite-volume Vlasov-Maxwell code for Plasma Physics simulations

    Language:Fortran14
  • Numerical-Methods-for-CFD

    MATLAB functions and scripts for 1D Computational Fluid Dynamics

    Language:MATLAB13
  • ConservationLawsDiffEq.jl

    Numeric Schemes for Conservation Laws

    Language:HTML13
  • finitevolume-jax

    Compressible Euler equations solved with finite volume implemented in JAX, plugged into an optimization loop

    Language:Python12
  • freeShearLayer

    A code based on the Finite Volume Method discretisation of Navier-Stokes equations for simulation of compressible shear layer

    Language:C12
  • PPR

    A high-order accurate piecewise polynomial reconstruction library.

    Language:Fortran12
  • nsc2ke

    Finite-Volume Galerkin program computing 2D and axisymmetric flows

    Language:Fortran12
  • tle-finitevolume

    Geophysical Tutorial - Pixels and their neighbors: Finite volume

    Language:Jupyter Notebook11
  • explicitSolidDynamics_vc

    Vertex centred code for explicit solid dynamics in OpenFOAM

    Language:C9
  • lax-wendroff-finite-volume

    Solving hyperbolic PDEs using the Lax-Wendroff Scheme and a finite volume method.

    Language:MATLAB9
  • SimpleBubblyFlowSolver

    SimpleBubblyFlowSolver

    Massively-parallelised Navier-Stokes solver with a volume-of-fluid method for bubbly flows

    Language:C8
  • Shallow_water_FV

    Solve the 2D shallow water equations with a finite volume method based on a Q-scheme

    Language:Fortran8
  • Shallow-Water-2D-Equations

    Implementation of Shallow Water Equations (works with Python 3.5 and Python 2.7)

    Language:Python8
  • Ananke.jl

    GPU Based 3D Finite Volume Fluid code written in Julia

    Language:Julia7
  • SimpleVOFSolver

    SimpleVOFSolver

    Massively-parallelised Navier-Stokes solver with a volume-of-fluid method for droplet-laden flows

    Language:C7
  • casingSimulations

    research code for running SimPEG simulations in settings with steel cased wells

    Language:Python7
  • pressio-demoapps

    Suite of 1D, 2D, 3D demo apps of varying complexity with built-in support for sample mesh and exact Jacobians

    Language:C++6
  • thermalporous

    DG0 solver for non-isothermal flow in porous media

    Language:Python6
  • BOLD_Toolbox

    Battery Optimal Layer Design (BOLD) Toolbox for optimising layer configuration of pouch cells

    Language:MATLAB6
  • godunov_method

    implementation of finite-volume Godunov method with flux splitting used to solve a system modelling barotropic gases

    Language:C++6
  • CFD_Short_Course

    Introductory course in Computational Fluid Dynamics

  • SplitFVM

    1D Finite-Volume with AMR and steady-state solver using Newton and Split-Newton. 1k+ downloads

    Language:Python4
  • Euler2D_Positive_Scheme

    Code in the paper PETER D. LAX AND XU-DONG LIU, SOLUTION OF TWO-DIMENSIONAL RIEMANN PROBLEMS OF GAS DYNAMICS BY POSITIVE SCHEMES, SIAM J. SCI. COMPUT. , Vol. 19, No. 2, pp. 319–340, March 1998

    Language:Fortran4
  • finite-volume

    :earth_asia: These projects are to create subsurface modeling based on geophysical formulas using finite volume method.

  • WENO-curvilinear

    Mathematica codes for weight derivation and stability analysis for Fifth-order finite volume Weighted essentially non-oscillatory scheme in orthogonally-curvilinear coordinates (Shadab et al., 2019)

    Language:Mathematica4
  • CFD-Project-Thermal-Energy-Storage

    Finite Volume Solver for 1D advection-diffusion using a Point Implicit Method written as part of a class project for "Fundamentals of CFD" course at ETH Zurich

    Language:C4
  • WENO-scalar

    A WENO solver for 1D scalar PDEs

    Language:Python3