Topic: "finite-difference"
devitocodes/devito
DSL and compiler framework for automated finite-differences and stencil computation
Language: Python - Size: 237 MB - Last synced at: 9 days ago - Pushed at: 10 days ago - Stars: 595 - Forks: 234

maroba/findiff
Python package for numerical derivatives and partial differential equations in any number of dimensions.
Language: Python - Size: 2.35 MB - Last synced at: 9 days ago - Pushed at: 4 months ago - Stars: 472 - Forks: 64

IBAMR/IBAMR
An adaptive and distributed-memory parallel implementation of the immersed boundary (IB) method
Language: C++ - Size: 122 MB - Last synced at: 3 days ago - Pushed at: 3 days ago - Stars: 380 - Forks: 149

bueler/p4pdes
C and Python examples from my book on using PETSc and Firedrake to solve PDEs
Language: C - Size: 4.48 MB - Last synced at: 3 days ago - Pushed at: 8 days ago - Stars: 197 - Forks: 72

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

JanThorbecke/OpenSource
Code for geophysical 3D/2D Finite Difference modelling, Marchenko algorithms, 2D/3D x-w migration and utilities.
Language: C - Size: 74.8 MB - Last synced at: 3 days ago - Pushed at: 4 days ago - Stars: 152 - Forks: 64

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

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: 5 days ago - Pushed at: 5 days ago - Stars: 114 - Forks: 30

314arhaam/heat-pinn
A Physics-Informed Neural Network to solve 2D steady-state heat equations.
Language: Jupyter Notebook - Size: 2.2 MB - Last synced at: 6 months ago - Pushed at: 6 months ago - Stars: 106 - Forks: 14

ranocha/SummationByPartsOperators.jl
A Julia library of summation-by-parts (SBP) operators used in finite difference, Fourier pseudospectral, continuous Galerkin, and discontinuous Galerkin methods to get provably stable semidiscretizations, paying special attention to boundary conditions.
Language: Julia - Size: 5.91 MB - Last synced at: 7 days ago - Pushed at: 13 days ago - Stars: 103 - Forks: 15

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

larsgeb/psvWave
Forward code for the P-SV wave equation on a staggered grid, with full waveform inversion interfaces. Finite difference approach according to stress-velocity formulation.
Language: Jupyter Notebook - Size: 74.7 MB - Last synced at: 9 days ago - Pushed at: almost 3 years ago - Stars: 71 - Forks: 10

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

fancompute/fdfdpy
Pure Python implementation of the finite difference frequency domain (FDFD) method for electromagnetics
Language: Jupyter Notebook - Size: 1.4 MB - Last synced at: 8 months ago - Pushed at: over 6 years ago - Stars: 53 - Forks: 17

dmitriy-kats/PhaseFieldGrainGrowthSimulations
These matlab codes simulate grain growth by solving the phase field equations using a centered finite difference method
Language: MATLAB - Size: 14.7 MB - Last synced at: over 1 year ago - Pushed at: about 6 years ago - Stars: 48 - Forks: 16

zaman13/Poisson-solver-2D
Finite difference solution of 2D Poisson equation. Can handle Dirichlet, Neumann and mixed boundary conditions.
Language: Python - Size: 831 KB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 47 - Forks: 14

eguidotti/calculus
High Dimensional Numerical and Symbolic Calculus in R
Language: R - Size: 2.34 MB - Last synced at: 5 months ago - Pushed at: about 2 years ago - Stars: 47 - Forks: 6

c0rychu/SchrodingerEq_1D_tutorial
Solving Schrodinger Equation Numerically
Language: Jupyter Notebook - Size: 40.3 MB - Last synced at: 7 days ago - Pushed at: over 2 years ago - Stars: 43 - Forks: 16

usnistgov/hiperc
High Performance Computing Strategies for Boundary Value Problems
Language: HTML - Size: 63.4 MB - Last synced at: 3 days ago - Pushed at: over 1 year ago - Stars: 42 - Forks: 10

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

stefanmeili/FastFD
A library for building finite difference simulations
Language: Python - Size: 60.2 MB - Last synced at: 2 days ago - Pushed at: almost 4 years ago - Stars: 34 - Forks: 6

ThomasThelen/Finite-Difference-Method
A Finite Difference Method Engine in C++
Language: C++ - Size: 7.84 MB - Last synced at: 15 days ago - Pushed at: over 2 years ago - Stars: 29 - Forks: 7

MahanFathi/Model-Based-RL
Model-based Policy Gradients
Language: Python - Size: 1.89 MB - Last synced at: 9 months ago - Pushed at: about 5 years ago - Stars: 29 - Forks: 4

isds-neu/PeRCNN
Encoding physics to learn reaction-diffusion processes
Language: Python - Size: 13.8 MB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 28 - Forks: 5

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: 19 days ago - Pushed at: about 5 years ago - Stars: 28 - Forks: 9

jessecaps/jCODE
High-order multiphase/multi-physics flow solver
Language: Fortran - Size: 2.23 MB - Last synced at: about 2 months ago - Pushed at: about 2 months ago - Stars: 25 - Forks: 5

LASG-GAMIL/GMCORE
A dynamical core for solving geophysical fluid equations on the sphere with conservative finite difference methods
Language: Fortran - Size: 1.28 MB - Last synced at: about 1 year ago - Pushed at: over 2 years ago - Stars: 20 - Forks: 8

inducer/numpde-notes
Slides/notes and Jupyter notebook demos for an introductory course of numerical methods for PDEs
Language: Jupyter Notebook - Size: 19.7 MB - Last synced at: 8 days ago - Pushed at: about 1 year ago - Stars: 19 - Forks: 8

xavierdechamps/Burgers_1D
Solve the 1D forced Burgers equation with high order finite elements and finite difference schemes.
Language: MATLAB - Size: 12.1 MB - Last synced at: almost 2 years ago - Pushed at: over 2 years ago - Stars: 19 - Forks: 2

ovcharenkoo/CUDA_FDTD_2D_acoustic_wave_propagation
Acoustic wave propagation in 2D domain using CUDA, O(2,8). Solve second order wave equation in time domain using finite-differences.
Language: Cuda - Size: 1.42 MB - Last synced at: about 2 years ago - Pushed at: about 6 years ago - Stars: 19 - Forks: 12

wesselb/fdm
Estimate derivatives with finite differences
Language: Python - Size: 6.11 MB - Last synced at: 7 days ago - Pushed at: 5 months ago - Stars: 17 - Forks: 3

arotem3/numerics
library of numerical methods using Armadillo
Language: C++ - Size: 3.44 MB - Last synced at: almost 2 years ago - Pushed at: about 3 years ago - Stars: 17 - Forks: 5

larsgeb/Rayleigh-Bernard
A simple finite difference scheme for the Rayleigh-Bernard equations (buoyancy driven convection).
Language: Python - Size: 1.95 MB - Last synced at: 19 days ago - Pushed at: over 4 years ago - Stars: 17 - Forks: 3

AndybnACT/GPU-comcot
GPU-comcot offloads the computational component on the outermost layer of COMCOT to Nvidia GPU. Currently, the speed up achieved by parallelized code on GTX-1060 comparing to serial one on AMD-FX8150 is nearly 200X. The code is still under development to fulfill the full functionality of the original model.
Language: Fortran - Size: 199 KB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 15 - Forks: 10

devitocodes/devito_book
Work in progress - Objective is to develop a comprehensive textbook on finite difference computing with Devito
Language: Jupyter Notebook - Size: 667 MB - Last synced at: 8 months ago - Pushed at: over 1 year ago - Stars: 14 - Forks: 6

gituliar/kwinto-cuda
Financial Analytics on GPU
Language: C++ - Size: 10.1 MB - Last synced at: 12 months ago - Pushed at: about 1 year ago - Stars: 13 - Forks: 2

munstermonster/cuSten
CUDA Finite Difference Library
Language: Cuda - Size: 903 KB - Last synced at: about 2 years ago - Pushed at: over 4 years ago - Stars: 13 - Forks: 4

myousefi2016/Cahn-Hilliard-CUDA
Cahn Hilliard CUDA (Phase-Field Simulation of Spinodal Decomposition)
Language: Cuda - Size: 1.88 GB - Last synced at: about 1 year ago - Pushed at: almost 6 years ago - Stars: 13 - Forks: 1

dkong8s93/p2d-model
Numerical Implementation (Finite Difference) of the Pseudo-two-Dimensional Model for Lithium-ion Batteries
Language: Matlab - Size: 30.3 KB - Last synced at: almost 2 years ago - Pushed at: almost 7 years ago - Stars: 13 - Forks: 3

nauaneed/PyDNS
Direct Numerical Simulation of Fluid Flow with IBM Using Python
Language: Jupyter Notebook - Size: 17 MB - Last synced at: about 2 years ago - Pushed at: almost 3 years ago - Stars: 12 - Forks: 4

chakravala/Adapode.jl
Adaptive P/ODE numerics with Grassmann element TensorField assembly
Language: Julia - Size: 133 KB - Last synced at: 7 days ago - Pushed at: 15 days ago - Stars: 11 - Forks: 0

myousefi2016/Allen-Cahn-CUDA
Allen Cahn CUDA (Phase-Field Simulation of Dendritic Solidification)
Language: Cuda - Size: 340 KB - Last synced at: about 1 year ago - Pushed at: over 6 years ago - Stars: 11 - Forks: 3

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

astr-code/astr
ASTR: A high-order FDM solver for turbulence and combustion
Language: Fortran - Size: 3.23 MB - Last synced at: 3 months ago - Pushed at: 3 months ago - Stars: 9 - Forks: 5

mhamilt/CoupledFDPlateAndString
Finite difference modelling of Kirchhoff thin plate coupled with stiff string(s)
Language: MATLAB - Size: 36 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 9 - Forks: 3

olivertso/pdepy
Finite-difference methods for solving initial and boundary value problems of some linear partial differential equations.
Language: Python - Size: 3.17 MB - Last synced at: about 1 year ago - Pushed at: about 4 years ago - Stars: 9 - Forks: 1

rishabhstein/Lid-driven-cavity
Navier-Stokes solver using FDM for 2D Lid driven cavity problem
Language: C - Size: 9.77 KB - Last synced at: 3 months ago - Pushed at: about 7 years ago - Stars: 9 - Forks: 4

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

myousefi2016/Cahn-Hilliard-MPI
Cahn Hilliard MPI (Phase-Field Simulation of Spinodal Decomposition)
Language: C++ - Size: 45.8 MB - Last synced at: about 1 year ago - Pushed at: over 4 years ago - Stars: 8 - Forks: 0

TiNezlobinsky/Finitewave
Open-source Python package for a wide range of tasks in modeling cardiac electrophysiology using finite-difference methods.
Language: Python - Size: 143 MB - Last synced at: 4 days ago - Pushed at: 5 days ago - Stars: 7 - Forks: 2

zhaonat/eigenwell
finite difference based eigensolving for Maxwell's equations and photonic structures
Language: Jupyter Notebook - Size: 14.1 MB - Last synced at: about 2 years ago - Pushed at: over 3 years ago - Stars: 7 - Forks: 3

williamjsdavis/continentalDeformationMAT
Modelling geologic scale continental deformation by the thin viscous sheet approximation
Language: MATLAB - Size: 16.6 MB - Last synced at: about 1 year ago - Pushed at: over 4 years ago - Stars: 7 - Forks: 1

ifilot/wavefuse
Gray-Scott reaction-diffusion system in 3D using CUDA
Language: C - Size: 3.49 MB - Last synced at: about 2 years ago - Pushed at: almost 6 years ago - Stars: 7 - Forks: 3

ctjacobs/compressible-rayleigh-taylor-instability
Solves the compressible Navier-Stokes equations using the finite difference method to simulate a 2D Rayleigh-Taylor instability.
Language: Cuda - Size: 6.84 KB - Last synced at: over 1 year ago - Pushed at: over 7 years ago - Stars: 7 - Forks: 1

real-space/AngstromCube
A parallel and GPU-accelerated Code for Real-Space All-Electron Linear-Scaling Density Functional Theory
Language: C++ - Size: 32.3 MB - Last synced at: 4 months ago - Pushed at: 4 months ago - Stars: 6 - Forks: 2

EladSharony/DiffMjStep
Custom Autograd Function for Differentiable MuJoCo Dynamics
Language: Python - Size: 43 KB - Last synced at: 9 days ago - Pushed at: 10 months ago - Stars: 6 - Forks: 1

manauref/PMGsolver
Parallel Multigrid solvers for Poisson, modified Helmholtz and implicit hyperdiffusion
Language: Fortran - Size: 262 KB - Last synced at: about 1 year ago - Pushed at: over 7 years ago - Stars: 6 - Forks: 2

AuroraDysis/Einstein.jl
Einstein.jl is a high-performance suite designed to compute arbitrary-precision solutions of PDEs in general relativity.
Language: Julia - Size: 3.06 MB - Last synced at: 16 days ago - Pushed at: 16 days ago - Stars: 5 - 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: 11 days ago - Pushed at: 2 months ago - Stars: 5 - Forks: 0

rbourgeois33/heat-equation-hpc-tools
Simple use case of the Kokkos, MPI and PDI libraries for solving the linear heat equation on a 2D cartesian mesh with periodic boundary condition.
Language: C++ - Size: 1.08 MB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 5 - Forks: 0

ray42/oomphlib
oomph-lib is an object-oriented, open-source finite-element library for the simulation of multi-physics problems. It is developed and maintained by Matthias Heil and Andrew Hazel of the School of Mathematics at The University of Manchester, along with many other contributors.
Language: C++ - Size: 469 MB - Last synced at: over 1 year ago - Pushed at: over 6 years ago - Stars: 5 - Forks: 0

ExeQuantCode/HeatFlow
Software for modelling time evolution of heat in systems by finite difference using Fourier and beyond-Fourier methods
Language: Fortran - Size: 14.7 MB - Last synced at: 11 days ago - Pushed at: 11 days ago - Stars: 4 - Forks: 0

NaokiHori/THINC-TC
THINC (volume-of-fluid) method for Taylor-Couette flows
Language: C - Size: 521 KB - Last synced at: 11 months ago - Pushed at: 11 months ago - Stars: 4 - Forks: 0

jbrillon/2D-compressible-Navier-Stokes
Solves the 2D compressible Navier-Stokes equations using finite-difference with a staggered grid arrangement to simulate acoustic waves.
Language: Python - Size: 89 MB - Last synced at: about 1 year ago - Pushed at: over 3 years ago - Stars: 4 - Forks: 1

ooreilly/sbp
Summation-by-parts
Language: C++ - Size: 240 KB - Last synced at: over 1 year ago - Pushed at: over 3 years ago - Stars: 4 - Forks: 2

real-space/juRS 📦
Real-space grid Density Functional Theory for large systems
Language: Fortran - Size: 4.42 MB - Last synced at: about 2 years ago - Pushed at: almost 4 years ago - Stars: 4 - Forks: 2

Hevenicio/Finite-Difference-Method-with-Python
Resolver o problema do valor limite com o método das diferenças finitas usando o número de intervalos m = 20
Language: Jupyter Notebook - Size: 150 KB - Last synced at: over 1 year ago - Pushed at: over 4 years ago - Stars: 4 - Forks: 1

grenkin/joker-fdm
Object-oriented constructor of finite difference schemes
Language: Matlab - Size: 2.57 MB - Last synced at: almost 2 years ago - Pushed at: over 6 years ago - Stars: 4 - Forks: 0

i05nagai/FiniteDifferences
Finite Difference Methods
Language: C++ - Size: 27.3 KB - Last synced at: about 2 years ago - Pushed at: almost 7 years ago - Stars: 4 - Forks: 3

xcompact3d/Old_Incompact3d 📦
Old version of our solver for the incompressible Navier-Stokes equations (no longer actively developed, please use the latest version of Incompact3d
Language: Fortran - Size: 142 KB - Last synced at: over 1 year ago - Pushed at: about 7 years ago - Stars: 4 - Forks: 2

martinezManuelF/AnisotropicTransmissionLine
A MATLAB script that simulates transmission lines embedded in anisotropic media.
Language: Matlab - Size: 747 KB - Last synced at: over 1 year ago - Pushed at: about 7 years ago - Stars: 4 - Forks: 0

zimmerrol/numerical-lib
Implementation of various different numerical methods for solving PDEs. Furthermore, solutions of more complex scenarios of heat transform are examined.
Language: C++ - Size: 125 MB - Last synced at: 17 days ago - Pushed at: over 7 years ago - Stars: 4 - Forks: 2

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

carlobortolan/quantrs
A (very) fast Rust library for quantitative finance.
Language: Rust - Size: 4.74 MB - Last synced at: 9 days ago - Pushed at: 16 days ago - Stars: 3 - Forks: 2

ohno/FiniteDifferenceMatrices.jl
A Julia package for discrete approximations of differential operators
Language: Julia - Size: 445 KB - Last synced at: 11 days ago - Pushed at: 8 months ago - Stars: 3 - Forks: 1

isuthermography/heatsim2
Finite difference simulator for heat conduction
Language: Python - Size: 425 KB - Last synced at: 12 months ago - Pushed at: 12 months ago - Stars: 3 - Forks: 1

gha3mi/fordiff
ForDiff - A Fortran library for numerical differentiation
Language: Fortran - Size: 700 KB - Last synced at: 21 days ago - Pushed at: about 1 year ago - Stars: 3 - Forks: 1

leo-aa88/finite_difference
Computes finite difference matrices for the first and second derivative up to sixth order, including compact schemes
Language: Python - Size: 502 KB - Last synced at: about 16 hours ago - Pushed at: over 3 years ago - Stars: 3 - Forks: 3

hansbrenna/sdycore_lab
The Simple Dynamical Core Lab is a personal project to explore some numerical algorithms involved in primitive equations models of atmospheric dynamics in a simplified setting
Language: Python - Size: 178 KB - Last synced at: about 1 year ago - Pushed at: about 4 years ago - Stars: 3 - Forks: 1

mhamilt/FDPlateClass
A finite difference plate scheme wrapped in a class
Language: C++ - Size: 146 KB - Last synced at: about 2 years ago - Pushed at: almost 5 years ago - Stars: 3 - Forks: 0

slimgroup/Software.siahkoohi2019TRnna
Neural network augmented wave-equation simulation by Siahkoohi, A., Louboutin, M., and Herrmann, F.J.
Language: Python - Size: 153 KB - Last synced at: 28 days ago - Pushed at: about 5 years ago - Stars: 3 - Forks: 0

hydrocoast/julia_training
Training Course of JuliaLang
Language: Julia - Size: 18.3 MB - Last synced at: about 2 years ago - Pushed at: almost 6 years ago - Stars: 3 - Forks: 0

CJBarry/Rflow
Tools for analysing and writing input and output files for USGS MODFLOW in R
Language: R - Size: 2.69 MB - Last synced at: about 1 year ago - Pushed at: almost 6 years ago - Stars: 3 - Forks: 0

dmitriy-kats/RayleighBenardConvection
This matlab code simulates Rayleigh Bernard convection using the Chorin scheme from computational fluid dynamics
Language: MATLAB - Size: 445 KB - Last synced at: over 1 year ago - Pushed at: about 6 years ago - Stars: 3 - Forks: 2

agdestein/Turbulox.jl
Turbulence in a box
Language: Julia - Size: 778 KB - Last synced at: 7 days ago - Pushed at: 7 days ago - Stars: 2 - Forks: 0

kolosovpetro/HistoryAndOverviewOfPolynomialP
Open research project on polynomial interpolation and approximation
Language: TeX - Size: 6.64 MB - Last synced at: 29 days ago - Pushed at: 29 days ago - Stars: 2 - Forks: 0

gpavanb1/SplitFDM 📦
1D Finite-Difference with AMR and steady-state solver using Newton and Split-Newton
Language: Python - Size: 66.4 KB - Last synced at: 19 days ago - Pushed at: 8 months ago - Stars: 2 - Forks: 0

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

tamaskis/Numerical_Differentiation_Toolbox-MATLAB
Functions and classes to evaluate derivatives, partial derivatives, gradients, directional derivatives, Jacobians, and Hessians.
Language: HTML - Size: 25.6 MB - Last synced at: about 1 year ago - Pushed at: over 1 year ago - Stars: 2 - Forks: 0

mahshadlotfinia/Stress316L
Machine Learning-Based Generalized Model for Finite Element Analysis of Roll Deflection During the Austenitic Stainless Steel 316L Strip Rolling
Language: MATLAB - Size: 3.09 MB - Last synced at: about 2 years ago - Pushed at: about 4 years ago - Stars: 2 - Forks: 3

ashwinvis/kdv-compact
Solving KdV equation with finite difference optimized compact scheme for first- and third-derivatives
Language: PostScript - Size: 1.14 MB - Last synced at: 2 days ago - Pushed at: over 4 years ago - Stars: 2 - Forks: 0

reach2sayan/ENGN_2020
Codes for the course ENGN 2020
Language: MATLAB - Size: 2.83 MB - Last synced at: about 2 years ago - Pushed at: almost 5 years ago - Stars: 2 - Forks: 2

zaman13/Matrix-Differentiation-Operators
Finite difference matrix operators for performing numerical differentiation in python.
Language: Python - Size: 113 KB - Last synced at: about 2 years ago - Pushed at: almost 5 years ago - Stars: 2 - Forks: 1

LorranSutter/DiscreteMethods
Discrete methods library
Language: Python - Size: 20.5 KB - Last synced at: about 2 months ago - Pushed at: almost 5 years ago - Stars: 2 - Forks: 0

EndCar808/cuThomasConstantBatch
Language: Cuda - Size: 12.7 KB - Last synced at: 7 days ago - Pushed at: over 5 years ago - Stars: 2 - Forks: 1

asinghvi17/diffusion-final
A flexible heat diffusion simulator written in Julia
Language: Julia - Size: 23.3 MB - Last synced at: about 2 months ago - Pushed at: about 6 years ago - Stars: 2 - Forks: 2

jzuern/continuum
A lightweight GPU-accelerated 2D physics library
Language: C++ - Size: 1.53 MB - Last synced at: about 2 years ago - Pushed at: almost 7 years ago - Stars: 2 - Forks: 0

FistOfHit/SpinningCylinders
Simulation of a conducting cylinder rotating inside a magnetic field. (Finite difference methods for non-linear systems of PDEs).
Language: Matlab - Size: 37.1 KB - Last synced at: 12 months ago - Pushed at: about 7 years ago - Stars: 2 - Forks: 0

alterat/Dynamics3-Lecture
From multiple degree-of-freedom to distributed systems: linear strings and sound synthesis
Language: Jupyter Notebook - Size: 1.93 MB - Last synced at: about 2 years ago - Pushed at: over 7 years ago - Stars: 2 - Forks: 0

martinjrobins/lattice_iterator
A N-dimensional lattice iterator for C++
Language: C++ - Size: 101 KB - Last synced at: about 2 months ago - Pushed at: almost 8 years ago - Stars: 2 - Forks: 0
