GitHub topics: heat-equation
gilbertfrancois/partial-differential-equations
Notes and examples on how to solve partial differential equations with numerical methods, using Python.
Language: Jupyter Notebook - Size: 35.1 MB - Last synced at: 9 days ago - Pushed at: about 2 years ago - Stars: 33 - Forks: 6

NemahAlsayed/HeatCanvas
The app solves the 2D heat equation numerically by applying boundary conditions.
Language: C# - Size: 1.52 MB - Last synced at: about 1 month ago - Pushed at: about 1 month ago - Stars: 0 - Forks: 0

emmanuelroque/pdefourier
A Maxima package to compute Fourier series and solve partial differential equations.
Size: 3.25 MB - Last synced at: about 2 months ago - Pushed at: about 2 months ago - Stars: 5 - Forks: 3

spatstat/spatstat.linnet
Sub-package of spatstat containing code for linear networks
Language: R - Size: 927 KB - Last synced at: about 2 months ago - Pushed at: about 2 months ago - Stars: 6 - Forks: 2

Alireza-Motazedian/Nonlinear_Optics_Second_Harmonic_Generation
Computational SHG Modeling — A complete Fortran-based framework for simulating thermal effects in Second Harmonic Generation using FDM and coupled physics.
Language: Gnuplot - Size: 15.9 MB - Last synced at: 2 months ago - Pushed at: 2 months ago - Stars: 1 - Forks: 0

andrei-punko/pde-solvers
A library for numerical solution of partial differential equations (PDE)
Language: Java - Size: 380 KB - Last synced at: 3 months ago - Pushed at: 3 months ago - Stars: 0 - Forks: 0

kaczajac/Heat-Equation-FEM-Solver
A python program that solves and plots heat equation using finite element method
Language: Python - Size: 85.9 KB - Last synced at: 5 months ago - Pushed at: 5 months ago - Stars: 0 - Forks: 0

Damien3008/HeatWave
Numerical solution of the heat equation in one and two dimensions.
Language: Python - Size: 8.55 MB - Last synced at: 5 months ago - Pushed at: 5 months ago - Stars: 2 - Forks: 0

Louis-Finegan/Convection-Diffusion-Models-Finite-Difference-Method-Python3
Applying the finite-difference method to the Convection Diffusion equation in python3. Examples included: One dimensional Heat equation, Transport equation, Fokker-Plank equation and some two dimensional examples.
Language: Python - Size: 70.6 MB - Last synced at: 4 months ago - Pushed at: about 1 year ago - Stars: 5 - Forks: 4

naderidev/heat-equation-simulation
Simulation of heat distribution in a rod with a spesefic length | Engineering Mathematics Project
Language: HTML - Size: 559 KB - Last synced at: 6 months ago - Pushed at: 6 months ago - Stars: 1 - Forks: 0

VictoorV/Projet2_Cpp
Résolution du problème de diffusion thermique en 2D dans un four.
Language: C++ - Size: 120 KB - Last synced at: 4 months ago - Pushed at: 6 months ago - Stars: 0 - Forks: 0

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

JoeJoe1313/Partial-Differential-Equations
Language: MATLAB - Size: 5.12 MB - Last synced at: 8 months ago - Pushed at: 8 months ago - Stars: 0 - Forks: 0

ericarocca/Heat-Equation-Solver
A Python solver for the 1D heat equation using the Crank-Nicolson method. Repository for the Software and Computing for Applied Physics course at the Alma Mater Studiorum - Università di Bologna
Language: Python - Size: 559 KB - Last synced at: 8 months ago - Pushed at: 8 months ago - Stars: 0 - Forks: 0

Rkiefe/HeatFEM3
The finite element method of the heat equation in 3D
Language: MATLAB - Size: 49.8 KB - Last synced at: 8 months ago - Pushed at: 8 months ago - Stars: 1 - Forks: 0

vuanhtuan1012/image-restoration
Image restoration by PDE and by Wavelet transform
Language: Matlab - Size: 1.26 MB - Last synced at: 29 days ago - Pushed at: over 8 years ago - Stars: 14 - Forks: 3

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: 9 months ago - Pushed at: 9 months ago - Stars: 106 - Forks: 14

rishabhstein/1-D-Heat-Equation
In this code pseudo-spectral method is used to solve one-dimensional heat equation.
Language: C++ - Size: 44.9 KB - Last synced at: 6 months ago - Pushed at: almost 7 years ago - Stars: 0 - Forks: 0

leo-aa88/heat-equation-2d
2D heat equation solver
Language: Python - Size: 129 KB - Last synced at: about 1 month ago - Pushed at: almost 4 years ago - Stars: 7 - Forks: 0

luibus/c_diffusion_temp
The following code runs a simulation of the heat diffusion equation for cylindrical coordinates
Language: C - Size: 20.5 KB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 0 - Forks: 0

iwhoppock/viscous_burgers
Two solutions, written in MATLAB, for solving the viscous Burger's equation. They are both spectral methods: the first is a Fourier Galerkin method, and the second is Collocation on the Tchebyshev-Gauß-Lobatto points.
Language: Matlab - Size: 1.8 MB - Last synced at: 10 months ago - Pushed at: about 8 years ago - Stars: 12 - Forks: 8

rvanvenetie/stbem
This code supplements arXiv:2108.03055, where we describe an adaptive boundary element method for the heat equation.
Language: Python - Size: 193 KB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 1 - Forks: 0

Ressnn/2DHeatEquationModel
A python model of the 2D heat equation
Language: Python - Size: 8.8 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 4 - Forks: 1

clemsadand/fem-master-thesis
Implémentation, de zéro jusqu'à la fin, d'une méthode d'éléments finis non conformes de Crouzeix-Raviart pour résoudre le cas dynamique problème de la chaleur
Language: MATLAB - Size: 1.05 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 0 - Forks: 0

brenttsss/numerical_analysis
Tutorials for MAM3040W Advanced Numerical Analysis
Language: Jupyter Notebook - Size: 1.29 MB - Last synced at: about 1 year ago - Pushed at: about 1 year ago - Stars: 0 - Forks: 0

ollenurb/heat
Heat simulation of a 2D plate using the finite difference method
Language: C++ - Size: 55.7 KB - Last synced at: over 1 year ago - Pushed at: over 3 years ago - Stars: 0 - Forks: 0

akarazeev/HeatEquation-5sem-MIPT-2016
Parallel C program in OpenMP and MPI (check branch MPIwOMP) - modelling of Heat Equation.
Language: C - Size: 6.79 MB - Last synced at: over 1 year ago - Pushed at: over 8 years ago - Stars: 3 - Forks: 0

vittoboa/parallel-computing
Parallel programs for scientific computing
Language: C++ - Size: 10.7 KB - Last synced at: over 1 year ago - Pushed at: over 2 years ago - Stars: 0 - Forks: 0

ray-chew/mmidk
Course material I created for the tutorial "Mathematical Modelling in Climate Research" at the Freie Universität Berlin
Language: Jupyter Notebook - Size: 42.5 MB - Last synced at: 5 months ago - Pushed at: over 1 year ago - Stars: 0 - Forks: 0

vitelot/Chemotaxis
Endothelial cells moving in a chemical field
Language: C - Size: 27.3 KB - Last synced at: over 1 year ago - Pushed at: over 2 years ago - Stars: 0 - Forks: 0

safibta/Bessel-function-of-first-kind-plot
bessel plot
Language: Mathematica - Size: 109 KB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 0 - Forks: 0

ElodieMillan/HeatEquation
This is simulations of Heat equation with python.
Language: Python - Size: 14.2 MB - Last synced at: over 1 year ago - Pushed at: over 5 years ago - Stars: 0 - Forks: 0

kocatepedogu/cellular-automaton-processor
A simple processor with a grid of cores that can only interact with their immediate neighbors
Language: SystemVerilog - Size: 211 KB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 0 - Forks: 0

mirianfsilva/heat-diffusion-equation
Finite-Difference Approximations to the Heat Equation. Implementation of schemes: Forward Time, Centered Space; Backward Time, Centered Space; Crank-Nicolson.
Language: Jupyter Notebook - Size: 37 MB - Last synced at: over 1 year ago - Pushed at: over 6 years ago - Stars: 24 - Forks: 0

k3jph/cmna-pkg
Computational Methods for Numerical Analysis
Language: R - Size: 325 KB - Last synced at: 4 months ago - Pushed at: almost 2 years ago - Stars: 16 - Forks: 9

perpendicooler/Computational_Fluid_Dynamics
Numerical Methods
Language: Jupyter Notebook - Size: 1.64 MB - Last synced at: 5 days ago - Pushed at: over 1 year ago - Stars: 0 - Forks: 0

weiwongg/PDE
Numerical Method for Solving Basic PDE
Size: 6.47 MB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 5 - Forks: 0

TWilliamBell/heateq
A low-dimensional heat equation solver written in Rcpp for two boundary conditions (Dirichlet, Neumann), this was developed as a method for teaching myself Rcpp.
Language: C++ - Size: 531 KB - Last synced at: over 1 year ago - Pushed at: almost 6 years ago - Stars: 2 - Forks: 1

brieuc-praud/Heat_FVM_2D
Two dimensional heat equation resolution with the help of the Finite Volume Method on a cartesian mesh
Language: Fortran - Size: 4.88 KB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 0 - Forks: 0

Sokolmish/heated_plate
Small research in numerical methods for partial differential equations solving
Language: Jupyter Notebook - Size: 114 KB - Last synced at: over 1 year ago - Pushed at: over 2 years ago - Stars: 0 - Forks: 0

UniversityProjects/FEM2
FEM for parabolic and mixed problems
Language: Matlab - Size: 2.4 MB - Last synced at: almost 2 years ago - Pushed at: over 8 years ago - Stars: 3 - Forks: 0

wakilsarfaraz/HEqSolver
This is a diffusion equation solver written in R
Language: R - Size: 201 KB - Last synced at: almost 2 years ago - Pushed at: over 6 years ago - Stars: 0 - Forks: 0

nathanzimniak/heat-equation
Un programme codé en Python pour résoudre l'équation de la chaleur à deux dimensions.
Language: Python - Size: 25.5 MB - Last synced at: 11 months ago - Pushed at: almost 4 years ago - Stars: 1 - Forks: 1

luciods/Deep-Learning-for-Heat-Equation-with-Neumann-Conditions
This project involves the use of classical neural networks for the computation of the heat equation with Neumann boundary conditions and a gaussian distribution as initial condition.
Size: 1.4 MB - Last synced at: over 1 year ago - Pushed at: almost 2 years ago - Stars: 0 - Forks: 0

AlbertoCuadra/inverse_problems
A collection of inverse problems (e.g., reconstruction of databases, algebraic reconstruction, topological derivatives, gravitational prospecting)
Language: MATLAB - Size: 60.5 MB - Last synced at: 4 months ago - Pushed at: almost 3 years ago - Stars: 2 - Forks: 0

CHoudrouge4/HeatMethodForGeodesicDistance
Computing the Geodesic distance using the heat method
Language: Java - Size: 5.74 MB - Last synced at: almost 2 years ago - Pushed at: almost 6 years ago - Stars: 1 - Forks: 1

adamsolomou/HeatWorld
Heat World difference equation using OpenCL
Language: C++ - Size: 155 KB - Last synced at: almost 2 years ago - Pushed at: over 7 years ago - Stars: 0 - Forks: 0

djps/SingleVesselHeat
Finite difference time domain code using operator splitting to solve coupled flow and heat equations.
Language: C++ - Size: 719 KB - Last synced at: 10 days ago - Pushed at: about 2 years ago - Stars: 0 - Forks: 0

v18nguye/IDwPDEs
Partial Differential Equations (PDEs) and its application in Image Restoration
Language: Python - Size: 11.1 MB - Last synced at: about 2 years ago - Pushed at: over 4 years ago - Stars: 1 - Forks: 1

camillechaize/Composite_Wall_MCP
TIPE sur l'utilisation des matériaux à changement de phase (MCP) dans l'isolation thermique des bâtiments. Modèle mathématique et résolution numérique.
Language: Python - Size: 843 KB - Last synced at: about 2 years ago - Pushed at: about 2 years ago - Stars: 3 - Forks: 1

PanosAntoniadis/pps-ntua
Lab exercises of Parallel Processing Systems course in NTUA
Language: C - Size: 10.8 MB - Last synced at: 6 months ago - Pushed at: over 5 years ago - Stars: 5 - Forks: 1

kimy-de/crank-nicolson-2d
Crank-Nicolson method for the heat equation in 2D
Language: Python - Size: 5.86 KB - Last synced at: about 2 years ago - Pushed at: almost 3 years ago - Stars: 2 - Forks: 0

salomon73/Noto-heat_equation
Heat diffusion, Turing patterns, Thermal dephasing
Language: Jupyter Notebook - Size: 1.47 MB - Last synced at: over 1 year ago - Pushed at: over 1 year ago - Stars: 0 - Forks: 0

Mephistopheles-0/julia-PDE-solver
Julia file that solves a partial differential equation (PDE) using three parts: (1) setting up the PDE, (2) defining the numerical method for solving the PDE, and (3) running the simulation
Language: Julia - Size: 3.91 KB - Last synced at: about 2 years ago - Pushed at: about 2 years ago - Stars: 0 - Forks: 0

UmarAhmed/pde-solver
Implementation of numerical solutions to PDES: Closest Point Method and Finite Difference Method
Language: Python - Size: 97.7 KB - Last synced at: about 2 years ago - Pushed at: about 2 years ago - Stars: 1 - Forks: 1

iwhoppock/heat_equation
A solution, written in C, to the heat equation using Crank-Nicholson and finite differences.
Language: C - Size: 777 KB - Last synced at: 10 months ago - Pushed at: about 8 years ago - Stars: 0 - Forks: 0

MrP01/HeatFun
Exploring the heat equation as part of a Special Topic for Approximation of Functions.
Language: TeX - Size: 37.2 MB - Last synced at: 5 months ago - Pushed at: about 2 years ago - Stars: 1 - Forks: 0

remisalmon/MPI_benchmark_solver 📦
Iterative solvers with MPI parallelization
Language: C - Size: 16.6 KB - Last synced at: over 2 years ago - Pushed at: over 6 years ago - Stars: 1 - Forks: 0

iamHrithikRaj/Numerical-Algorithm
In numerical analysis, a numerical method is a mathematical tool designed to solve numerical problems. The implementation of a numerical method with an appropriate convergence check in a programming language is called a numerical algorithm
Language: C++ - Size: 34.2 KB - Last synced at: over 2 years ago - Pushed at: about 5 years ago - Stars: 4 - Forks: 0

kauniska/MicroprocessorCooling
This code solves for the steady-state heat transport in a 2D model of a microprocessor, ceramic casing and an aluminium heatsink. It uses either Jacobi or Gauss-Seidel relaxation method on a finite difference grid. It can be run with the microprocessor only, microprocessor and casing, or microprocessor with casing and heatsink. Options for either forced or natural convection. Result can be plotted as a temperature heatmap over the grid.
Language: Python - Size: 394 KB - Last synced at: over 1 year ago - Pushed at: over 4 years ago - Stars: 0 - Forks: 0

joaomlneto/cpds-heat
Heat Equation using different solvers (Jacobi, Red-Black, Gaussian) in C using different paradigms (sequential, OpenMP, MPI, CUDA) - Assignments for the Concurrent, Parallel and Distributed Systems course @ UPC 2013
Language: C - Size: 49.8 KB - Last synced at: 3 months ago - Pushed at: about 6 years ago - Stars: 7 - Forks: 4

kuldeep-tolia/Numerical_Methods_Codes
Various numerical methods are discussed to solve different problems numerically.
Language: C++ - Size: 734 KB - Last synced at: over 2 years ago - Pushed at: over 2 years ago - Stars: 1 - Forks: 0

planelles20/PyConES-HaciendoMates
Charla en la PyConEs-2016 (http://2016.es.pycon.org/es/).
Language: Jupyter Notebook - Size: 11.7 KB - Last synced at: over 1 year ago - Pushed at: almost 9 years ago - Stars: 1 - Forks: 2

NikolaKostadinov/thermal
TPLS is a small Erlang project with the goal of simulating how heat diffuses through a given region using a lattice of processes
Language: Erlang - Size: 90.8 KB - Last synced at: almost 2 years ago - Pushed at: almost 3 years ago - Stars: 0 - Forks: 0

pmontalb/PdeFiniteDifferenceSolver
C++/CUDA implementation of the most popular hyperbolic and parabolic PDE solvers
Language: C++ - Size: 30.7 MB - Last synced at: over 2 years ago - Pushed at: almost 4 years ago - Stars: 18 - Forks: 5

leoEspin/heat2D
Parallel C++ solver for the 2D heat equation
Language: C++ - Size: 941 KB - Last synced at: over 2 years ago - Pushed at: about 3 years ago - Stars: 0 - Forks: 0

GoshaSerbin/HeatEquation-with-FEM
Численное решение уравнения теплопроводности в 1D и 2D методом конечных элементов. Задаются граничные условия I, II, III рода, произвольная сетка
Language: C++ - Size: 9.77 KB - Last synced at: about 2 years ago - Pushed at: about 3 years ago - Stars: 0 - Forks: 0

namper/Numerical-Analysis
Numerical Analysis 2019 (TSU) Final Project
Language: Python - Size: 773 KB - Last synced at: over 2 years ago - Pushed at: over 5 years ago - Stars: 3 - Forks: 1

vitkarpenko/FEM-with-backward-Euler-for-the-heat-equation
:fire: Solving the heat equation on square plate with finite element method in Python.
Language: TeX - Size: 18.4 MB - Last synced at: 2 months ago - Pushed at: almost 9 years ago - Stars: 2 - Forks: 0

brnd-from-mars/HeatTransport
2D Finite-Volume-Method for Heat-Transport-Equation
Language: Python - Size: 3.91 KB - Last synced at: about 2 years ago - Pushed at: about 3 years ago - Stars: 0 - Forks: 0

axothy/HeatEquation
Heat Equation solver C++. Solves heat equation (One-dimensional case)
Language: C++ - Size: 1.17 MB - Last synced at: about 2 years ago - Pushed at: almost 4 years ago - Stars: 0 - Forks: 0

CDOrtona/Image_Inpainting
Image inpainting algorithm based on two methods: Interpolation and Diffusion through the resolution of a linear PDE. This was my project for the Numerical Methods class held at the Univeristy of Bologna, Italy.
Language: MATLAB - Size: 6.41 MB - Last synced at: over 2 years ago - Pushed at: almost 3 years ago - Stars: 0 - Forks: 1

standing-o/Heat_Equation
Numerical solutions of heat equations
Language: MATLAB - Size: 12.7 KB - Last synced at: over 2 years ago - Pushed at: over 3 years ago - Stars: 0 - Forks: 0

PedroLFerreira/Wildpyre
A Semi-Continuous Wildfire Model using the Heat Equation
Language: Jupyter Notebook - Size: 25.6 MB - Last synced at: over 1 year ago - Pushed at: over 7 years ago - Stars: 0 - Forks: 0

Gtoyos/ThetaMethod-HeatEquation
Analysis and implementation of the theta iterative method for solving the non homogeneous heat equation under Cauchy Dirichlet conditions. Numerical Methods course project of Facultad de Ingenieria - UDELAR.
Language: MATLAB - Size: 4.01 MB - Last synced at: over 2 years ago - Pushed at: over 3 years ago - Stars: 0 - Forks: 0

olafx/periodic_heat
heat integration
Language: Python - Size: 3.32 MB - Last synced at: over 1 year ago - Pushed at: over 3 years ago - Stars: 0 - Forks: 0

mluckyw/AN_heatcond_1D
1D Heat Conduction Equation with custom user input using analytical solutions
Language: MATLAB - Size: 222 KB - Last synced at: over 2 years ago - Pushed at: about 4 years ago - Stars: 1 - Forks: 0

msedalatzadeh/Optimal-predictor-design
In this repository, optimal estimation of change in temperature state is discussed using deep learning and shape optimization techniques.
Language: Python - Size: 715 MB - Last synced at: 8 months ago - Pushed at: about 4 years ago - Stars: 0 - Forks: 0

eugnsp/memristor
Simple model of a memristor
Language: C++ - Size: 2.41 MB - Last synced at: about 2 years ago - Pushed at: almost 6 years ago - Stars: 1 - Forks: 1

krashkov/Blog
Source code for blog posts at krashkov.com
Language: Jupyter Notebook - Size: 1.89 MB - Last synced at: about 1 month ago - Pushed at: about 5 years ago - Stars: 0 - Forks: 0

TDaryaT/Computer_methods_reports
MMF NSU. CM laboratory works, 3 course 1 semester. Convection and heat equation.
Language: TeX - Size: 1.61 MB - Last synced at: 30 days ago - Pushed at: almost 5 years ago - Stars: 1 - Forks: 0

fblupi/PyOpenCL-exercises
Exercises done during "Short course on high performance simulation with high level languages" imparted by André Brodtkorb
Language: Python - Size: 3.91 KB - Last synced at: 4 months ago - Pushed at: over 9 years ago - Stars: 1 - Forks: 1

DelSquared/Partial-Differential-Equations
Language: Jupyter Notebook - Size: 120 KB - Last synced at: about 1 month ago - Pushed at: almost 7 years ago - Stars: 1 - Forks: 1

suicide-squad/heat-equation
Уравнение теплопроводности в трёхмере
Language: C - Size: 30.1 MB - Last synced at: over 2 years ago - Pushed at: about 7 years ago - Stars: 0 - Forks: 3

PetrovKP/heat-equation Fork of suicide-squad/heat-equation
Уравнение теплопроводности в трёхмере
Language: C - Size: 30.1 MB - Last synced at: 16 days ago - Pushed at: about 7 years ago - Stars: 0 - Forks: 0

planelles20/fenics-examples
Solving some examples of partial differential equations (PDE) using fenics.
Language: Python - Size: 22 MB - Last synced at: over 1 year ago - Pushed at: over 7 years ago - Stars: 0 - Forks: 2
