GitHub topics: finite-volume
michaeltouati/ESVM
Finite-volume Vlasov-Maxwell code for Plasma Physics simulations
Language: Fortran - Size: 8.15 MB - Last synced at: about 10 hours ago - Pushed at: about 11 hours ago - Stars: 14 - Forks: 3

python-hydro/pyro2
A framework for hydrodynamics explorations and prototyping
Language: Jupyter Notebook - Size: 140 MB - Last synced at: about 9 hours ago - Pushed at: about 2 months ago - Stars: 314 - Forks: 125

INTERA-Inc/pyvista-gridder
Mesh generation using PyVista
Language: Python - Size: 1.37 MB - Last synced at: 4 days ago - Pushed at: 5 days ago - Stars: 3 - Forks: 1

code-saturne/code_saturne
code_saturne public mirror
Language: C++ - Size: 162 MB - Last synced at: 6 days ago - Pushed at: 6 days ago - Stars: 246 - Forks: 86

xgcm/xgcm
python package for analyzing general circulation model output data
Language: Python - Size: 58.7 MB - Last synced at: 4 days ago - Pushed at: 8 days ago - Stars: 237 - Forks: 82

simpeg/simpeg
Simulation and Parameter Estimation in Geophysics - A python package for simulation and gradient based parameter estimation in the context of geophysical applications.
Language: Python - Size: 88.6 MB - Last synced at: 8 days ago - Pushed at: 8 days ago - Stars: 544 - Forks: 273

stfc/PSyclone
Domain-specific compiler and code transformation system for Finite Difference/Volume/Element Earth-system models in Fortran
Language: Python - Size: 343 MB - Last synced at: 6 days ago - Pushed at: 6 days ago - Stars: 114 - Forks: 30

pmocz/finitevolume-python
Finite Volume simulation of the Kelvin-Helmholtz Instability
Language: Python - Size: 36.1 KB - Last synced at: 10 days ago - Pushed at: almost 2 years ago - Stars: 135 - Forks: 34

SINTEF-AppliedCompSci/MRST
Official GitHub repository for MRST - the MATLAB Reservoir Simulation Toolbox
Language: MATLAB - Size: 329 MB - Last synced at: 8 days ago - Pushed at: 8 days ago - Stars: 75 - Forks: 27

ITHACA-FV/ITHACA-FV
Reduced order modelling techniques for OpenFOAM
Language: C++ - Size: 94.4 MB - Last synced at: 13 days ago - Pushed at: 13 days ago - Stars: 187 - Forks: 104

devsim/devsim
TCAD Semiconductor Device Simulator
Language: C++ - Size: 51.7 MB - Last synced at: about 9 hours ago - Pushed at: 4 months ago - Stars: 192 - Forks: 68

lukbrb/fvNd-unit-test
Results and descriptions of unit tests run with fv1d, fv2d or fv3d.
Size: 7.41 MB - Last synced at: 15 days ago - Pushed at: 15 days ago - Stars: 1 - Forks: 0

cpraveen/chpde
Computational Hyperbolic PDE
Language: Fortran - Size: 5.25 MB - Last synced at: 18 days ago - Pushed at: 18 days ago - Stars: 5 - Forks: 0

pmocz/cfd-comparison-python
Comparison of various numerical methods for computational fluid dynamics
Language: Python - Size: 435 KB - Last synced at: 10 days ago - Pushed at: over 1 year ago - Stars: 69 - Forks: 6

Pressio/pressio-demoapps
Suite of 1D, 2D, 3D demo apps of varying complexity with built-in support for sample mesh and exact Jacobians
Language: C++ - Size: 69.7 MB - Last synced at: 12 days ago - Pushed at: 19 days ago - Stars: 9 - Forks: 2

Eicosane-2/Schemi
Homebrew Godunov-type computational fluid dynamics solver with some additional physics.
Language: C++ - Size: 1.13 MB - Last synced at: about 22 hours ago - Pushed at: about 23 hours ago - Stars: 0 - Forks: 0

haranjackson/PyPDE
A Python library for solving any system of hyperbolic or parabolic Partial Differential Equations. The PDEs can have stiff source terms and non-conservative components.
Language: C++ - Size: 1.54 MB - Last synced at: 8 days ago - Pushed at: over 5 years ago - Stars: 57 - Forks: 9

gimli-org/gimli
Geophysical Inversion and Modeling Library :earth_africa:
Language: Python - Size: 33 MB - Last synced at: 10 days ago - Pushed at: 19 days ago - Stars: 401 - Forks: 144

simpeg/discretize
Discretization tools for finite volume and inverse problems.
Language: Python - Size: 56 MB - Last synced at: 5 days ago - Pushed at: about 2 months ago - Stars: 175 - Forks: 35

ray-chew/pyBELLA
A Python-based Blended sEamLess soLver for Atmospheric dynamics coupled to an ensemble data assimilation engine
Language: Python - Size: 172 MB - Last synced at: 21 days ago - Pushed at: 3 months ago - Stars: 5 - Forks: 1

cpraveen/numpde
Codes for my numerical methods for PDE course
Language: Jupyter Notebook - Size: 3.17 MB - Last synced at: 28 days ago - Pushed at: 28 days ago - Stars: 8 - Forks: 7

pkestene/euler2d_kokkos
Simple 2d finite volume solver for Euler equations using c++ kokkos library
Language: C++ - Size: 6.5 MB - Last synced at: 16 days ago - Pushed at: about 2 months ago - Stars: 41 - Forks: 8

GeoscienceAustralia/anuga_core
AnuGA for the simulation of the shallow water equation
Language: Python - Size: 48.4 MB - Last synced at: 11 days ago - Pushed at: about 1 year ago - Stars: 202 - Forks: 97

soumyasen1809/12-Steps-to-Navier-Stokes
CFD Python, a.k.a. the 12 steps to Navier-Stokes taught by Prof. Lorena Barba
Language: Python - Size: 8.79 KB - Last synced at: 20 days ago - Pushed at: about 5 years ago - Stars: 28 - Forks: 9

vavrines/Kinetic.jl
Universal modeling and simulation of fluid mechanics upon machine learning. From the Boltzmann equation, heading towards multiscale and multiphysics flows.
Language: Julia - Size: 7.01 MB - Last synced at: about 9 hours ago - Pushed at: about 1 month ago - Stars: 134 - Forks: 17

baw-de/poroMechanicalFoam
Extension to OpenFOAM and solids4Foam to model coupled flow and deformation in porous media
Language: C - Size: 302 KB - Last synced at: about 1 month ago - Pushed at: about 1 month ago - Stars: 2 - Forks: 1

harryzhou2000/DNDSR
High order compact finite volume implementation, N-S equation solver plus RANS models.
Language: C++ - Size: 97.1 MB - Last synced at: 7 days ago - Pushed at: 7 days ago - Stars: 2 - Forks: 0

SHUD-System/SHUD
Simulator for Hydrologic Unstructured Domains (SHUD) --- multi-scale and multi-process integrated hydrological model
Language: C++ - Size: 12.9 MB - Last synced at: 2 days ago - Pushed at: over 1 year ago - Stars: 36 - Forks: 11

pkestene/euler_kokkos
Compressible hydro and magneto-hydrodynamics (2nd order Godunov) implemented with MPI+Kokkos
Language: C++ - Size: 945 KB - Last synced at: 16 days ago - Pushed at: about 1 month ago - Stars: 33 - Forks: 3

pmocz/finitevolume2-python
Create Your Own Finite Volume Fluid Simulation (With Python) Part 2: Boundary Conditions and Source Terms
Language: Python - Size: 67.4 KB - Last synced at: 10 days ago - Pushed at: almost 2 years ago - Stars: 31 - Forks: 6

soumyasen1809/CFD_books_codes
CFD codes written based on examples in various books like Patnakar, Versteeg etc
Language: Python - Size: 7.37 MB - Last synced at: 20 days ago - Pushed at: almost 5 years ago - Stars: 50 - Forks: 19

heruslu/Numerical-Methods-for-CFD
MATLAB functions and scripts for 1D Computational Fluid Dynamics
Language: Matlab - Size: 272 KB - Last synced at: 27 days ago - Pushed at: over 6 years ago - Stars: 13 - Forks: 1

pkestene/ramsesGPU
Astrophysics MHD simulation code optimized for large cluster of GPU
Language: C++ - Size: 5.82 MB - Last synced at: 19 days ago - Pushed at: 4 months ago - Stars: 58 - Forks: 11

pmocz/finitevolume-jax
Compressible Euler equations solved with finite volume implemented in JAX, plugged into an optimization loop
Language: Python - Size: 1.29 MB - Last synced at: about 1 month ago - Pushed at: 10 months ago - Stars: 20 - Forks: 0

gpavanb1/SplitFXM
1D Finite-Difference/Volume with AMR and steady-state solver using Newton and Split-Newton with sparse Jacobian
Language: Python - Size: 3.13 MB - Last synced at: 12 days ago - Pushed at: 2 months ago - Stars: 5 - Forks: 0

INSIGNEO/openBF
1D blood flow simulator
Language: Julia - Size: 4.66 MB - Last synced at: 6 days ago - Pushed at: 3 months ago - Stars: 37 - Forks: 17

NaokiHori/SimpleVOFSolver
Massively-parallelized Navier-Stokes solver with a volume-of-fluid method for droplet-laden flows
Language: C - Size: 16.6 MB - Last synced at: 3 months ago - Pushed at: 3 months ago - Stars: 8 - Forks: 0

pkestene/ppkMHD
MPI+Kokkos implementation of spectral difference method (SDM) high order schemes
Language: C++ - Size: 2.23 MB - Last synced at: 16 days ago - Pushed at: 3 months ago - Stars: 26 - Forks: 6

clawpack/pyclaw
PyClaw is a Python-based interface to the algorithms of Clawpack and SharpClaw. It also contains the PetClaw package, which adds parallelism through PETSc.
Language: Fortran - Size: 15 MB - Last synced at: 3 months ago - Pushed at: 3 months ago - Stars: 166 - Forks: 102

eigemx/unvpp
A C++17 library for reading Ideas-UNV mesh format
Language: C++ - Size: 17.3 MB - Last synced at: 4 months ago - Pushed at: 4 months ago - Stars: 1 - Forks: 1

furstj/myFoam
Additional OpenFOAM solvers for compressible flows
Language: C++ - Size: 4.09 MB - Last synced at: 3 months ago - Pushed at: 3 months ago - Stars: 38 - Forks: 17

KiT-RT/kitrt_code
A high performance framework for radiation therapy simulation and numerical solutions for kinetic equations.
Language: C++ - Size: 402 MB - Last synced at: about 2 months ago - Pushed at: 3 months ago - Stars: 22 - Forks: 3

szaghi/OFF
OFF, Open source Finite volume Fluid dynamics code
Language: Fortran - Size: 43.9 MB - Last synced at: 2 months ago - Pushed at: over 5 years ago - Stars: 130 - Forks: 59

simulkade/FVTool
Finite volume toolbox for Matlab/Octave
Language: MATLAB - Size: 5 MB - Last synced at: 5 months ago - Pushed at: 5 months ago - Stars: 100 - Forks: 56

maelk3/openCL-FV-solver
A compressible Euler equation GPU finite volume solver to simulate the Kelvin-Helmholtz instability.
Language: C - Size: 604 KB - Last synced at: about 1 month ago - Pushed at: 10 months ago - Stars: 2 - Forks: 0

DLR-AMR/t8gpu
Header-only finite volume library targetting GPUs using t8code as meshing backend.
Language: C++ - Size: 2.99 MB - Last synced at: 6 months ago - Pushed at: 7 months ago - Stars: 0 - Forks: 0

pmocz/constrainedtransport-python
Finite Volume Constrained Transport MHD simulation of the Orszag-Tang vortex
Language: Python - Size: 254 KB - Last synced at: 10 days ago - Pushed at: almost 2 years ago - Stars: 17 - Forks: 3

MFlowCode/MicroFC
A micro MFC and CFD mini-app
Language: Fortran - Size: 35.3 MB - Last synced at: 7 months ago - Pushed at: about 2 years ago - Stars: 0 - Forks: 0

pkestene/euler2d_cudaFortran
2nd order Godunov solver for 2d Euler equations written in CUDA Fortran and stdpar (standard paralelism)
Language: Fortran - Size: 250 KB - Last synced at: 16 days ago - Pushed at: over 1 year ago - Stars: 36 - Forks: 8

haranjackson/phd
The working repository for my PhD project at the Centre for Scientific Computing, Cambridge
Language: C++ - Size: 105 MB - Last synced at: 5 months ago - Pushed at: about 5 years ago - Stars: 25 - Forks: 6

gpavanb1/SplitFVM 📦
1D Finite-Volume with AMR and steady-state solver using Newton and Split-Newton. 2k+ downloads
Language: Python - Size: 143 KB - Last synced at: 12 days ago - Pushed at: 8 months ago - Stars: 4 - Forks: 0

DelNov/T-Flows
Program for Simulation of Turbulent Flows
Language: Fortran - Size: 197 MB - Last synced at: 7 months ago - Pushed at: 7 months ago - Stars: 109 - Forks: 48

Fastaxx/1DCutCell
Language: Julia - Size: 10.7 KB - Last synced at: 9 months ago - Pushed at: 9 months ago - Stars: 1 - Forks: 0

ImperialCollegeESE/BOLD_Toolbox
Battery Optimal Layer Design (BOLD) Toolbox for optimising layer configuration of pouch cells
Language: Matlab - Size: 80.1 KB - Last synced at: 5 months ago - Pushed at: almost 7 years ago - Stars: 6 - Forks: 2

acuoci/CFDofReactiveFlows
Collection of codes in Matlab(R) and C++ for solving basic problems presented and discussed in the "Computational Fluid Dynamics of Reactive Flows" course (Politecnico di Milano)
Language: MATLAB - Size: 1.21 MB - Last synced at: 11 months ago - Pushed at: over 3 years ago - Stars: 69 - Forks: 20

eigemx/prism
A Computational fluid dynamics library based on finite-volume method
Language: C++ - Size: 29.9 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 0 - Forks: 0

truongdangqe/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: Fortran - Size: 2.44 MB - Last synced at: about 1 month ago - Pushed at: over 5 years ago - Stars: 4 - Forks: 1

simpeg-research/casingSimulations
research code for running SimPEG simulations in settings with steel cased wells
Language: Python - Size: 66.5 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 7 - Forks: 4

tlroy/thermalporous
DG0 solver for non-isothermal flow in porous media
Language: Python - Size: 18.5 MB - Last synced at: 17 days ago - Pushed at: over 4 years ago - Stars: 6 - Forks: 3

Alexsaphir/FiniteVolume-Refinement
M2 MACS: Implémentation d'une méthode de volumes finis 1D utilisant un algorithme de raffinement
Language: Jupyter Notebook - Size: 2.93 MB - Last synced at: about 1 year ago - Pushed at: over 5 years ago - Stars: 1 - Forks: 0

lmn-labest/fortranFVCell
⚔️
Language: Fortran - Size: 10.4 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 2 - Forks: 1

byrneta/Computational-Fluid-Dynamics
:cyclone: Selected MATLAB code I wrote while taking a CFD class in graduate school. Finite-difference and finite volume approximations are compared to analytical solutions. Project descriptions are included. :cyclone:
Language: MATLAB - Size: 864 KB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 34 - Forks: 10

heySourabh/CFDSolver
Computational Fluid Dynamics Solver
Language: Java - Size: 25.1 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 31 - Forks: 8

fppimenta/rheoTool
Toolbox to simulate GNF and viscoelastic fluid flows in OpenFOAM®
Language: C++ - Size: 32.8 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 138 - Forks: 65

python-hydro/hydro_examples
Simple one-dimensional examples of various hydrodynamics techniques
Language: Jupyter Notebook - Size: 666 KB - Last synced at: about 1 year ago - Pushed at: almost 4 years ago - Stars: 105 - Forks: 69

Slaedr/FVENS
Finite volume Euler / Navier-Stokes solver
Language: C++ - Size: 61.2 MB - Last synced at: about 1 year ago - Pushed at: over 1 year ago - Stars: 47 - Forks: 20

simpeg/tle-finitevolume
Geophysical Tutorial - Pixels and their neighbors: Finite volume
Language: Jupyter Notebook - Size: 12.4 MB - Last synced at: about 1 year ago - Pushed at: over 1 year ago - Stars: 10 - Forks: 4

vahadruya/Investigation_of_CFD_methods_on_the_Lid-Driven_Cavity_Problem
A simple investigation into various CFD methods (like SF-Vorticity approach, primitive variable FDM, FVM etc.) by using the Lid-Driven Cavity problem as an example
Language: Jupyter Notebook - Size: 39.6 MB - Last synced at: about 1 year ago - Pushed at: over 1 year ago - Stars: 2 - Forks: 0

vahadruya/Observations_on_the_k-scheme_for_linear_Hyperbolic_PDE
basic investigation into the general k-scheme using the example of a simple linear hyperbolic 1D PDE
Language: Jupyter Notebook - Size: 11.2 MB - Last synced at: about 1 year ago - Pushed at: over 1 year ago - Stars: 1 - Forks: 0

brli3/CFD
Basic Computational Fluid Dynamics (CFD) schemes implemented in FORTRAN using Finite-Volume and Finite-Difference Methods. Sample simulations and figures are provided.
Language: Fortran - Size: 7.58 MB - Last synced at: about 1 year ago - Pushed at: over 4 years ago - Stars: 140 - Forks: 63

Paulms/ConservationLawsDiffEq.jl
Numeric Schemes for Conservation Laws
Language: HTML - Size: 368 KB - Last synced at: about 1 year ago - Pushed at: almost 5 years ago - Stars: 13 - Forks: 10

wme7/ApproximateRiemannSolvers
My personal collection of Riemann solvers using MUSCL and WENO schemes written as short Matlab scripts
Language: Matlab - Size: 25.5 MB - Last synced at: about 1 year ago - Pushed at: over 6 years ago - Stars: 76 - Forks: 37

jibranhaider/explicitSolidDynamics_vc
Vertex centred code for explicit solid dynamics in OpenFOAM
Language: C - Size: 3.79 MB - Last synced at: about 1 year ago - Pushed at: over 3 years ago - Stars: 7 - Forks: 2

jibranhaider/explicitSolidDynamics
Cell centred code for explicit solid dynamics in OpenFOAM
Language: C - Size: 100 MB - Last synced at: about 1 year ago - Pushed at: over 3 years ago - Stars: 51 - Forks: 19

mashadab/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: Mathematica - Size: 710 KB - Last synced at: about 1 year ago - Pushed at: over 3 years ago - Stars: 4 - Forks: 3

HenriqueCCdA/Heat1D
⚔️
Language: C++ - Size: 7.57 MB - Last synced at: about 1 year ago - Pushed at: over 2 years ago - Stars: 0 - Forks: 0

xavierdechamps/Shallow_water_FV
Solve the 2D shallow water equations with a finite volume method based on a Q-scheme
Language: Fortran - Size: 52.7 MB - Last synced at: over 1 year ago - Pushed at: about 2 years ago - Stars: 8 - Forks: 0

cpraveen/nsc2ke
Finite-Volume Galerkin program computing 2D and axisymmetric flows
Language: Fortran - Size: 1.43 MB - Last synced at: about 1 year ago - Pushed at: almost 7 years ago - Stars: 12 - Forks: 7

DavidCico/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: Fortran - Size: 1.81 MB - Last synced at: about 1 year ago - Pushed at: over 2 years ago - Stars: 19 - Forks: 9

simulkade/JFVM.jl
A simple finite volume tool for Julia
Language: Julia - Size: 1.58 MB - Last synced at: about 1 year ago - Pushed at: about 2 years ago - Stars: 42 - Forks: 13

mheriyanto/finite-volume
:earth_asia: These projects are to create subsurface modeling based on geophysical formulas using finite volume method.
Size: 1.95 KB - Last synced at: 3 days ago - Pushed at: about 5 years ago - Stars: 4 - Forks: 0

weigert/TinyFluid
FV based Navier-Stokes / Transport Equation / Conservation Law Solver for Procedural World Simulation. Designed for CFD learning purposes.
Language: C++ - Size: 34.7 MB - Last synced at: about 1 year ago - Pushed at: over 4 years ago - Stars: 18 - Forks: 2

gkigiermo/parallel-heat-transfer
A classic MPI communication scheme for domain decomposition in 2D structured grids
Language: C++ - Size: 143 KB - Last synced at: about 1 year ago - Pushed at: over 1 year ago - Stars: 0 - Forks: 0

antoinediez/SOH.jl
Self-Organized Hydrodynamics PDE solver in Julia
Language: Julia - Size: 473 KB - Last synced at: about 1 year ago - Pushed at: about 3 years ago - Stars: 2 - Forks: 0

nikola-m/freeCappuccino
A three-dimensional unstructured finite volume code for fluid flow simulations.
Language: Fortran - Size: 27.5 MB - Last synced at: about 1 year ago - Pushed at: about 3 years ago - Stars: 49 - Forks: 25

alfiogn/Compute-Errors
A small library to perform numerical error computation in the OpenFOAM framework
Language: C - Size: 28.3 KB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 1 - Forks: 0

dengwirda/PPR
A high-order accurate piecewise polynomial reconstruction library.
Language: Fortran - Size: 411 KB - Last synced at: about 1 year ago - Pushed at: almost 3 years ago - Stars: 11 - Forks: 11

cperales/Shallow-Water-2D-Equations
Implementation of Shallow Water Equations (works with Python 3.5 and Python 2.7)
Language: Python - Size: 22.8 MB - Last synced at: about 1 year ago - Pushed at: almost 3 years ago - Stars: 8 - Forks: 3

YixiongRen/Biomedical
mass-transfer programm for biomedical case
Language: Matlab - Size: 13.7 KB - Last synced at: about 1 year ago - Pushed at: about 7 years ago - Stars: 1 - Forks: 0

MHDFlows/Ananke.jl
GPU Based 3D Finite Volume Fluid code written in Julia
Language: Julia - Size: 69.3 KB - Last synced at: 12 months ago - Pushed at: over 1 year ago - Stars: 5 - Forks: 2

comp-physics/WENO-scalar
A WENO solver for 1D scalar PDEs
Language: Python - Size: 5.86 KB - Last synced at: about 1 year ago - Pushed at: over 3 years ago - Stars: 3 - Forks: 1

VishalKandala/Py-ler
This is a 2-D Finite Volume solver that solves the Euler equations (Laminar, Inviscid flow) The solver is based on the famous Jameson-Turkel-Schmidt (JST) scheme. Implements Explicit euler psuedo time marching.
Language: Python - Size: 20.5 KB - Last synced at: about 1 year ago - Pushed at: almost 5 years ago - Stars: 0 - Forks: 0

valenpe7/godunov_method
implementation of finite-volume Godunov method with flux splitting used to solve a system modelling barotropic gases
Language: C++ - Size: 396 KB - Last synced at: about 1 year ago - Pushed at: about 9 years ago - Stars: 6 - Forks: 4

traiwitchung/FlowSimulation
Solving Flow-Simulation using finite volume method, The main code requires FVTool and MRST to run
Language: MATLAB - Size: 19.5 KB - Last synced at: about 1 month ago - Pushed at: over 4 years ago - Stars: 2 - Forks: 1

nikola-m/freeShearLayer
A code based on the Finite Volume Method discretisation of Navier-Stokes equations for simulation of compressible shear layer
Language: C - Size: 1.01 MB - Last synced at: about 1 year ago - Pushed at: over 6 years ago - Stars: 11 - Forks: 4

DamynChipman/ShallowWater
A simple shallow water equation simulation in MATLAB.
Language: MATLAB - Size: 11.2 MB - Last synced at: about 1 year ago - Pushed at: about 3 years ago - Stars: 0 - Forks: 0

truongdangqe/FVM_AdvectionDiffusion_1D
Finite volume code for 1D advection-diffusion equation with periodic BCs.
Language: C++ - Size: 7.81 KB - Last synced at: about 1 month ago - Pushed at: about 4 years ago - Stars: 2 - Forks: 1

azzeddinetiba/Rope_Wave_Equation
Numerical solution of the wave equation of a rope
Language: Python - Size: 16.3 MB - Last synced at: about 1 year ago - Pushed at: over 4 years ago - Stars: 0 - Forks: 1

vavrines/SPM
finite volume solver for radiative transfer equation
Language: C++ - Size: 9.18 MB - Last synced at: about 1 year ago - Pushed at: over 2 years ago - Stars: 2 - Forks: 0

MarieBichette/XVOF
One dimensional hydro code for testing xfem method
Language: Python - Size: 62.9 MB - Last synced at: about 1 year ago - Pushed at: almost 3 years ago - Stars: 2 - Forks: 2
