dealii
There are 66 repositories under dealii topic.
precice/precice
A coupling library for partitioned multi-physics simulations, including, but not restricted to fluid-structure interaction and conjugate heat transfer simulations.
pymor/pymor
pyMOR - Model Order Reduction with Python
exadg/exadg
ExaDG - High-Order Discontinuous Galerkin for the Exa-Scale
cpraveen/dflo
Discontinuous Galerkin solver for compressible flows
mdforbes500/short-crack-model
A short-crack finite element model incorporating both crystal plasticity and phase-field modeling of the crack geometry.
cpraveen/fem
Codes for finite element method
mathLab/deal2lkit
A ToolKit library for deal.II
UCL-CCS/SCEMa
HMM implementation featuring Deal.II (FE) and LAMMPS (MD)
mdh266/Semiconductor_Device_Simulator
Semiconductor Device Simulator in 2D and 3D
mdh266/Distributed_Poisson_Solver
Distributed Poisson Equation Solver Using The Local Discontinuous Galerkin Method
BBahtiri/LSTM_assisted_viscoelastic_viscoplastic_model
A finite element implementation of a viscoelastic viscoplastic constitutive model using the deal.ii library with the option to include a pretrained Deep-Learning model
raulinve/Isogeometric-Analysis-with-Deal.II
🌀〰️ Isogeometric Analysis classes for the deal.II FE library.
jppelteret/dealii-weak_forms
An implementation of a symbolic weak form interface for deal.II, using expression templates as well as automatic and symbolic differentiation.
mdh266/Advection_Solver
Solves the steady-state advection equation using the discontinuous Galerkin method.
Hendrik240298/deal.II_Crash_Course_2023
This repository provides the coding material for the deal.ii crash course of the 10th deal.II Users and Developers Workshop (https://www.dealii.org/workshop-2023/)
jfriedlein/2D_axial-symmetry_plane-strain_dealii
Proposal of a framework and functions to handle 2D computations such as axial symmetry or plane strain in deal.ii
jfriedlein/Automatic_differentiation_for_material_modelling-dealii
Functions and guide to use automatic differentiation for material modelling in deal.II on the element and QP level
jfriedlein/Numerical_examples_in_dealii
A collection of different numerical examples implemented in deal.ii. Besides the geometry and mesh, the scripts also apply the boundary conditions if desired.
marcfehling/FEM-TikZ
Display two-dimensional numerical grids in LaTeX.
Resonance-Group/Omni-FEM
The development repository for the Omni-FEM simulator
FracThePermian/Finite-Element-Method-ICES-deal.ii
Elastic-Plastic Deformation on a 2-D Plane
j507/gCP
Monolithic solver for strain-gradient crystal visco-plasticity with cohesive grain boundaries
konsim83/MPI-Parallel-Multiscale-Diffusion-FEM
Elliptic Multiscale FEM with MPI (and distributed mesh)
mdh266/PECS
Photoelctrochemical Solar Cell Simulator
IamNikolayTverdokhleb/riverDischarge2D
2D model of river discharge into the see, solver uses Finite Elements approach.
IamNikolayTverdokhleb/riverDischargeModel3D
Finite elements solver for hydrodynamics equation. Current version is tuned to model river discharge into the sea with sea3d-whole2.unv mesh. Using deal.II for matrix resolutions.
marcfehling/hpbox
Sandbox for hp-adaptive methods
mdh266/Multithreaded_Poisson_Solver
Multithreaded Poisson Equation solver which uses the mixed finite element method
pankajkumar9797/Convection-equation
A finite element model for solving the convection-diffusion equation
peterrum/deal-and-ceed-on-gpu
CEED BP5 implementation for GPU using deal.II
cembooks/static
Supplemented computer code for the book "Electromagnetics with finite elements: static problems" ISBN 978-9090380933
fdrmrc/DG_advection_reaction_suite
A collection of C++ programs that solve advection -reaction problems using DG (Discontinuous Galerkin) upwind methods with a reliable error estimator
fdrmrc/non_matching_test_suite
Different approaches to impose interface conditions with non matching techniques
fdrmrc/stokes_solver
C++ programs that solve, adaptively, the Stokes equations in 2D, using block preconditioners and exploiting MPI parallelisation. Time marching using ARKODE wrappers is still ongoing
melanie-t27/Cardiac-Electrophysiology
Cardiac Electrophysiology MPI implementation for the Numerical Methods for PDEs (NMPDE) Course @POLIMI (Prof. Alfio Maria Quarteroni, TA Michele Bucelli)
sfu-nml/flexodeal-lite
A simplified, tutorial-like, all-in-one-code version of the Flexodeal library.