poisson-equation
There are 92 repositories under poisson-equation topic.
macs3-project/MACS
MACS -- Model-based Analysis of ChIP-Seq
rjwalia/Navier-Stokes-Numerical-Solution-Using-FDM-FVM-LBM-Solver-Python-Scripting
Python script for Linear, Non-Linear Convection, Burger’s & Poisson Equation in 1D & 2D, 1D Diffusion Equation using Standard Wall Function, 2D Heat Conduction Convection equation with Dirichlet & Neumann BC, full Navier-Stokes Equation coupled with Poisson equation for Cavity and Channel flow in 2D using Finite Difference Method & Finite Volume Method.
nepluno/apic2d
Affine Particle-in-Cell Water Simulation in 2D
JuliaPhysics/SolidStateDetectors.jl
Solid state detector field and charge drift simulation in Julia
zaman13/Poisson-solver-2D
Finite difference solution of 2D Poisson equation. Can handle Dirichlet, Neumann and mixed boundary conditions.
emhayki/CFD-Fundamental
Implementation of the 12 steps approach to the Navier-Stokes equations, essential for simulating fluid dynamics.
rsugimoto/WoBToolbox
Author's implementation of SIGGRAPH 2023 paper, "A Practical Walk-on-Boundary Method for Boundary Value Problems."
MarcoForte/poisson-matting
Python implementation of Poisson matting method
miniufo/xinvert
Invert geophysical fluid dynamic problems (elliptic partial differential equations) using SOR iteration method.
bchao1/fast-poisson-image-editing
Fast, scalable, and extensive implementations of Poisson image editing algorithms.
dw-shin/basic_fem_tutorial
FEM Tutorial for Beginners
akapet00/locally-adaptive-activation-functions
Simplified implementation of locally adaptive activation functions (LAAF) with slope recovery for deep and physics-informed neural networks (PINNs) in PyTorch.
StarsX/PoissonSolver
DirectX 11 Poisson solvers using Jacobi iteration, conjugate gradient, and multi-grid method respectively.
LaurentNevou/Q_SchrodingerPoisson1D_demo
Schrodinger-Poisson solver in 1D demonstrator
amkatrutsa/dmg
Source code for Deep Multigrid method https://arxiv.org/pdf/1711.03825.pdf
justachetan/VirtualElementMethods
A Python implementation of the paper "The virtual element method in 50 lines of MATLAB" by Oliver J. Sutton
giovannipizzi/SchrPoisson-2DMaterials
A Schrödinger-Poisson solver for 2D materials with 1D interfaces (wires)
matthiasnwt/fast-poisson-solver
The Poisson equation is an integral part of many physical phenomena, yet its computation is often time-consuming. This module presents an efficient method using physics-informed neural networks (PINNs) to rapidly solve arbitrary 2D Poisson problems.
s-ankur/montecarlo-pde
Monte Carlo Method to Solve Laplace and Poisson Equations with example for EE447 High Voltage Engineering
rsugimoto/VelMCFluids
Author's implementation of SIGGRAPH 2024 paper, "Velocity-Based Monte Carlo Fluids"
bchao1/poissonpy
📈 poissonpy is a Python Poisson Equation library for scientific computing, image and video processing, and computer graphics.
ljungdahl/fftw-Poisson-example
An example of a solution to the 3D Poisson's equation using in-place, real-to-complex, discrete Fourier transform with the FFTW library (fftw.org).
sairamkolla/poison_image_blending
poisson equation for image blending
rorysroes/Fast_Algorithm_FPS_SSA
Implement F-DST to solve 2-D PDE(fast poisson solver) and FFT to compute Multiplication algorithm(Schönhage–Strassen algorithm) with C
araujo88/cnavier
Explicit incompressible Navier-stokes solver written in C based on finite-difference schemes
arkavo/poissonCUDA
NVIDIA CUDA Poisson Solver
elvissoares/PyDFTele
The Density Functional Theory for Electrolyte Solutions
eugnsp/surface_arpes
Calculator of ARPES spectra for depletion/accumulation surface layers
LaurentNevou/Q_Poisson1D
Poisson solver for semiconductor hetero-structures
allegro0132/PyQHE
Python scripts for exploring the quantum hall effect.
ivan-pi/poisson_lbm
A small collection of 1D Poisson solvers based on the lattice Boltzmann method
LaurentNevou/Q_SchrodingerPoisson1D_Dirichlet_demo
Schrodinger-Poisson solver with Dirichlet boundary condition
harry7557558/img23d
Web-based tool that turns 2D images into smooth 3D models.
lucasamtaylor01/FiniteDiff-Poisson
Estudo do Problema de Dirichlet para a Equação de Poisson com Discretização Finita 🔍
magshaban/Poisson2D_FEM
This program Solves Poisson 2D equation using Finite element method.