boundary-value-problem
There are 26 repositories under boundary-value-problem topic.
NeuroDiffGym/neurodiffeq
A library for solving differential equations using neural networks based on PyTorch, used by multiple research groups around the world, including at Harvard IACS.
arotem3/numerics
library of numerical methods using Armadillo
Mathias-Fuchs/MinimalSurface
compute an approximate minimal surface without recursion ("in one shot")
pnkraemer/diffeqzoo
A zoo of implementations of differential equation problems in NumPy and JAX. Oscillators, chemical reactions, n-body problems, epidemiological models, IVPs, BVPs, and more.
xijunke/Conceptual-design-and-application-of-insect-bioinspired-FWMAV
Bio-insect flapping wing micro aerial vehicle (FWMAV) is a kind of centimeter-scale air-flying robot which imitates the flapping-wing motion pattern of flying insects in order to realize flying ability and agile maneuverability similar to flapping-winged flying insects. Because of its future broad application prospects in the field of military and civilian, at present, the development of bio-insect FWMAV has become a hot research topic of some important scientific research institutions and units at home and abroad.
gpavanb1/RFS
Robust Flamelet Solver: Mixture-Fraction based Flamelet solver with arc-length continuation
PyNumAl/Python-Numerical-Analysis
Implementation of Numerical Analysis algorithms/methods in Python
Papelbon/numerical-anal
Numerical Analysis Problems and Solutions
tokarevart/polymgen
PolyMGen is a library for parallel quality mesh generation of many polytopes, such as polygons and polyhedrons
avrtt/finite-element-method
Two-dimensional finite element method on rectangles
readikole/Picewise-linear-Rayleigh-Ritz
I use piecewise linear function to approximate the solution to a boundary value problem.
perazz/twopnt
A Modern Fortran translation of the TWOPNT program for Boundary Value Problems
reece-iriye/Solving-2D-Poissons-Equation-Using-Finite-Difference-Method-and-Iterative-Solvers
Implementing 2D Poisson's Equation using the Finite Difference Method and Iterative Solvers for matrices. Explored LU decomposition & the Thomas algorithm, Jacobi, Gauss-Seidel, and the Standard Over-Relaxation (SOR) method. MATH 4315: Advanced Scientific Computing with Professor Weihua Geng.
ThangLe-duc/hnPINN_for_PDEs
This work proposes a hierarchically normalized physics-informed neural network (hnPINN) to solve PDE problems.
DavidPoves/BVP-Solver
General Boundary Value Problem solver based on Scipy's solve_bvp algorithm.
ishika1234-sudo/Numerical-analysis-codes
The repository contains python code for 2D steady-state heat diffusion problems in different coordinate systems like cartesian, polar, spherical etc. This is a topic of numerical analysis, where methods like shooting method, finite difference method, CVM and weighted residual methods are used to solve a particular BVP. Python code has been developed for the same and graphs have been made to monitor the heat transfer within the system.
pika-pikachu/BoundaryCrossingProbabilities.jl
Computes the boundary crossing probability for a general diffusion process and time-dependent boundary.
nicolassoam/dcc008-numeric-calculus
Repositório com implementações de métodos numéricos em Python desenvolvido ao longo da disciplina DCC008X - Cálculo Numérico
PradanyaBoro/Numerical_Methods
This repository provides essential numerical algorithms for solving mathematical problems. Covering linear equations, differential equations and more, it's a valuable resource for students and professionals in science and engineering.
wingkitlee0/scikits.bvp_solver
Python package for solving two-point boundary value problems that wraps BVP_SOLVER
Gaurav-Van/NPTEL-Advanced-Computational-Techniques
Formulas of this year's [2024] NPTEL Course titled Advanced Computational Techniques
jatin-47/numerical_methods_lab_iitkgp
NUMERICAL METHODS LABORATORY (MA29202) / NUMERICAL TECHNIQUES LABORATORY (MA39110) - IIT KGP
leonel11/KaschenkoEquation
Modelling of oscillating loss of stability for the trivial solution for the boundary-value problem with a linear deviate with a delay in the boundary condition
rabestro/BoundaryValues
What boundary values to choose for good tests?
rudrasohan/Numerical_Solutions
A repo for keeping various numerical Solvers
tokarevart/parallel-ensembling
C++ OpenMP and CUDA implementation of parallel ensembling of global stiffness matrix.