Rheolef  7.2
an efficient C++ finite element environment
 
Loading...
Searching...
No Matches
examples Directory Reference

Files

 bdf.icc
 BDF(p) backward differentiation formula – coefficients.
 
 burgers.icc
 The Burgers equation – the f function.
 
 burgers_dg.cc
 The Burgers equation by the discontinous Galerkin method.
 
 burgers_diffusion_dg.cc
 The diffusive Burgers equation by the discontinuous Galerkin method.
 
 burgers_diffusion_error.cc
 The diffusive Burgers equation – error analysis.
 
 burgers_diffusion_exact.h
 The diffusive Burgers equation – its exact solution.
 
 burgers_diffusion_operators.icc
 The diffusive Burgers equation – operators.
 
 burgers_flux_godunov.icc
 The Burgers equation – the Godonov flux.
 
 cahouet-chabart.h
 The Cahouet-Chabart preconditioner for the Navier-Stokes equations.
 
 cavity.h
 The driven cavity benchmark: 2D boundary conditions.
 
 cavity_3d.h
 The driven cavity benchmark: 3D boundary conditions.
 
 cavity_dg.h
 The driven cavity benchmark: right-hand-side and boundary conditions for the discontinuous Galerkin method.
 
 combustion.h
 The combustion problem: class header for the Newton method.
 
 combustion1.icc
 The combustion problem: class body for the Newton method.
 
 combustion2.icc
 The combustion problem: class body for the Newton method.
 
 combustion_continuation.cc
 The combustion problem by continuation.
 
 combustion_error.cc
 The combustion problem – error analysis.
 
 combustion_exact.icc
 The combustion problem – its exact solution.
 
 combustion_keller.cc
 The combustion problem by Keller continuation.
 
 combustion_keller_post.cc
 The combustion problem by Keller continuation – post-treatment.
 
 combustion_newton.cc
 The combustion problem by the Newton method.
 
 combustion_post.cc
 The combustion problem – post-treatment.
 
 commute_rtd.cc
 Discontinuous Raviart-Thomas L2 projection.
 
 commute_rtd_error.cc
 Discontinuous Raviart-Thomas L2 projection – error analysis.
 
 contraction.h
 The contraction geometry: boundary conditions.
 
 convect.cc
 Convection-diffusion equation by the method of characteristics.
 
 convect2.cc
 Convection-diffusion equation by BDF2 scheme and the method of characteristics.
 
 convect_error.cc
 Convection-diffusion equation by the method of characteristics – error analysis.
 
 convect_hdg.cc
 Convection-diffusion equation by the hybrid discontinuous Galerkin method.
 
 convect_hdg_error.cc
 Convection-diffusion equation by the hybrid discontinuous Galerkin method.
 
 cosinus_vector.h
 The cosinus vector function.
 
 cosinusprod.h
 The cosinus product function.
 
 cosinusprod_dirichlet.h
 The cosinus product function – right-hand-side and boundary condition for the Poisson problem.
 
 cosinusprod_error.cc
 The cosinus product function – error analysis for the Poisson problem.
 
 cosinusprod_error_dg.cc
 The cosinus product function – error analysis for the discontinuous Galerkin method.
 
 cosinusprod_error_hdg.cc
 The sinus product function – error analysis for the hybrid discontinuous Galerkin method.
 
 cosinusprod_error_hdg_average.cc
 The sinus product function – error analysis for the hybrid discontinuous Galerkin method.
 
 cosinusprod_error_hdg_post_rt.cc
 The sinus product function – error analysis for the hybrid discontinuous Galerkin method.
 
 cosinusprod_grad.h
 The cosinus product function – its gradient.
 
 cosinusprod_helmholtz.h
 The cosinus product function – right-hand-side and boundary condition for the Helmholz problem.
 
 cosinusprod_laplace.h
 The cosinus product function – right-hand-side and boundary condition for the Laplace problem.
 
 cosinusprod_post_dg.cc
 The cosinus product function – post-treatment with the discontinuous Galerkin method.
 
 cosinusrad.h
 The cosinus radius function.
 
 cosinusrad_error.cc
 The cosinus product function – error analysis for the Poisson problem.
 
 cosinusrad_laplace.h
 The cosinus radius function – right-hand side and boundary condition.
 
 d_projection_dx.h
 The projection for yield-stress rheology – its derivative.
 
 diffusion_isotropic.h
 Tensor diffusion – isotropic case.
 
 diffusion_tensor.cc
 The tensor diffusion benchmark.
 
 diffusion_tensor_error.cc
 The tensor diffusion benchmark – error computation.
 
 diffusion_tensor_exact.icc
 The tensorial diffusion benchmark – right-hand-side and exact solution.
 
 diffusion_transport_tensor_dg.cc
 The tensor transport-diffusion benchmark with the discontinuous Galerkin method.
 
 diffusion_transport_tensor_error_dg.cc
 The tensor transport-diffusion benchmark – error computation.
 
 diffusion_transport_tensor_exact.icc
 The tensor transport-diffusion benchmark – right-hand-side and exact solution.
 
 dirichlet-nh.cc
 The Poisson problem with non-homogeneous Dirichlet boundary conditions.
 
 dirichlet.cc
 The Poisson problem with homogeneous Dirichlet boundary conditions.
 
 dirichlet.icc
 The Poisson problem with homogeneous Dirichlet boundary condition – solver function.
 
 dirichlet2-ball.cc
 The Poisson problem with homogeneous boundary conditions – variable right-hand-side.
 
 dirichlet2.cc
 The Poisson problem with homogeneous boundary conditions – variable right-hand-side.
 
 dirichlet_dg.cc
 The Poisson problem by the discontinuous Galerkin method.
 
 dirichlet_dg_lazy.cc
 The Poisson problem by the discontinuous Galerkin method.
 
 dirichlet_hdg.cc
 The Poisson problem by the hybrid discontinuous Galerkin method.
 
 dirichlet_hdg_average.cc
 The Poisson problem by the hybrid discontinuous Galerkin method – local averaging.
 
 dirichlet_hdg_average.icc
 The Poisson problem by the hybrid discontinuous Galerkin method – local averaging function.
 
 dirichlet_hdg_post.cc
 The Poisson problem by the hybrid discontinuous Galerkin method – post-treatment.
 
 dirichlet_hdg_post_rt.cc
 The Poisson problem by the hybrid discontinuous Galerkin method – post-treatment with the Raviart-Thomas element.
 
 dirichlet_hho.cc
 The Poisson problem by the hybrid high order method.
 
 dirichlet_hho_debug.cc
 The Poisson problem by the hybrid high order method.
 
 dirichlet_hho_v2.cc
 The Poisson problem by the hybrid high order method.
 
 dirichlet_homogeneous.h
 The Poisson problem with homogeneous Dirichlet boundary conditions – right-hand-side and boundary condition.
 
 dirichlet_nh_ball.cc
 The Poisson problem with non-homogeneous Dirichlet boundary conditions.
 
 elasticity_criterion.icc
 The elasticity problem – adaptive mesh criterion.
 
 elasticity_solve.icc
 The elasticity problem – solver function.
 
 elasticity_taylor_dg.cc
 The elasticity problem with the Taylor benchmark and discontinuous Galerkin method.
 
 elasticity_taylor_error_dg.cc
 The elasticity problem with the Taylor benchmark and discontinuous Galerkin method – error analysis.
 
 embankment.cc
 The elasticity problem for the embankment geometry.
 
 embankment.icc
 The elasticity problem for the embankment geometry – boundary conditions.
 
 embankment_adapt.cc
 The elasticity problem for the embankment geometry with adaptive mesh.
 
 embankment_dg.cc
 
 embankment_dg.icc
 
 eta.h
 The p-Laplacian problem – the eta function.
 
 harten.h
 The Burgers problem: the Harten exact solution.
 
 harten0.h
 The Burgers problem: the Harten exact solution at t=0.
 
 harten_error.cc
 
 harten_show.cc
 The Burgers problem: the Harten exact solution – visualization.
 
 heat.cc
 The heat equation.
 
 helmholtz_band.cc
 The Helmholtz problem on a surface by the banded level-set method.
 
 helmholtz_band_error.cc
 
 helmholtz_band_iterative.cc
 The Helmholtz problem on a surface by the banded level-set method – iterative solver.
 
 helmholtz_s.cc
 The Helmholtz problem on a surface.
 
 helmholtz_s_error.cc
 The Helmholtz problem on a surface – error analysis.
 
 incompressible-elasticity-check.cc
 
 incompressible-elasticity.cc
 The incompressible elasticity problem for the embankment geometry.
 
 inertia.h
 The inertia term of the Navier-Stokes equation with the discontinuous Galerkin method – di Pietro & Ern variant.
 
 inertia_cks.icc
 The inertia term of the Navier-Stokes equation with the discontinuous Galerkin method – Cockburn, Kanschat & Schotzau variant.
 
 inertia_upw.icc
 The inertia term of the Navier-Stokes equation with the discontinuous Galerkin method – upwinding variant.
 
 lambda2alpha.h
 The combustion problem – inversion of the parameter function.
 
 lambda_c.cc
 The combustion problem – the criitical parameter value.
 
 lambda_c.h
 The combustion problem – the critical parameter value as a function.
 
 laplace_band.cc
 The Poisson problem on a surface by the banded level set method.
 
 laplace_band_error.cc
 
 laplace_s.cc
 The Poisson problem on a surface.
 
 laplace_s_error.cc
 
 level_set_sphere.cc
 Extraction as a surface mesh of the zero level set – spherical geometry.
 
 level_set_sphere_check.cc
 
 level_set_torus.cc
 Extraction as a surface mesh of the zero level set – spherical geometry.
 
 leveque.h
 The Leveque benchmark – function definition.
 
 leveque_dg.cc
 The Leveque benchmark by discontinuous Galerkin method.
 
 mosolov_augmented_lagrangian.cc
 The Mossolov problem by the augmented Lagrangian method.
 
 mosolov_augmented_lagrangian.h
 The Mossolov problem by the augmented Lagrangian method – solver class header.
 
 mosolov_augmented_lagrangian1.icc
 The Mossolov problem by the augmented Lagrangian method – solver class body.
 
 mosolov_augmented_lagrangian2.icc
 The Mossolov problem by the augmented Lagrangian method – solver class body.
 
 mosolov_error.cc
 The Mossolov problem for a circular pipe – error analysis.
 
 mosolov_error_yield_surface.cc
 The Mossolov problem for a circular pipe – error analysis for the yield surface.
 
 mosolov_exact_circle.h
 The Mossolov problem for a circular pipe – exact solution.
 
 mosolov_residue.cc
 The Mossolov problem – residue analysis.
 
 mosolov_yield_surface.cc
 The Mossolov problem – yield surface.
 
 navier_stokes_cavity.cc
 The Navier-Stokes equations on the driven cavity benchmark with the method of characteristics.
 
 navier_stokes_cavity_newton_dg.cc
 The Navier-Stokes equations for the Taylor benchmark by Newton and discontinuous Galerkin methods.
 
 navier_stokes_cavity_newton_upw_dg.cc
 The Navier-Stokes equations for the Taylor benchmark by Newton and discontinuous Galerkin methods.
 
 navier_stokes_criterion.cc
 
 navier_stokes_criterion.icc
 The Navier-Stokes equations – adaptive mesh criterion.
 
 navier_stokes_dg.h
 The Navier-Stokes equations with the discontinuous Galerkin method – class header.
 
 navier_stokes_dg1.icc
 The Navier-Stokes equations with the discontinuous Galerkin method – class body.
 
 navier_stokes_dg2.icc
 The Navier-Stokes equations with the discontinuous Galerkin method – class body.
 
 navier_stokes_solve.icc
 The Navier-Stokes equations with the method of characteristics – solver function.
 
 navier_stokes_taylor_cks_dg.cc
 The Navier-Stokes equations for the Taylor benchmark with fixed-point and discontinuous Galerkin methods – di Pietro & Ern variant.
 
 navier_stokes_taylor_dg.cc
 The Navier-Stokes equations for the Taylor benchmark with fixed-point and discontinuous Galerkin methods – di Pietro & Ern variant.
 
 navier_stokes_taylor_error_dg.cc
 The Navier-Stokes equations for the Taylor benchmark – error analysis.
 
 navier_stokes_taylor_newton_dg.cc
 The Navier-Stokes equations for the Taylor benchmark by Newton and discontinuous Galerkin methods.
 
 navier_stokes_upw_dg.h
 The Navier-Stokes equations with the discontinuous Galerkin method and upwinding – class header.
 
 navier_stokes_upw_dg.icc
 The Navier-Stokes equations with the discontinuous Galerkin method and upwinding – class body.
 
 neumann-laplace-check.cc
 
 neumann-laplace-lambda.cc
 The Poisson problem with Neumann boundary conditions.
 
 neumann-laplace.cc
 The Poisson problem with Neumann boundary conditions.
 
 neumann-nh.cc
 The Helmholtz problem with Neumann boundary conditions.
 
 neumann.cc
 
 neumann_dg.cc
 The Helmholtz problem with Neumann boundary conditions by the discontinuous Galerkin method.
 
 nu.h
 The p-Laplacian problem – the nu function.
 
 oldroyd_cavity.cc
 The Oldroyd problem on the contraction benchmark.
 
 oldroyd_cavity.h
 The Oldroyd problem on the driven cavity benchmark – boundary conditions.
 
 oldroyd_contraction.cc
 The Oldroyd problem on the contraction benchmark.
 
 oldroyd_contraction.h
 The Oldroyd problem on the contraction benchmark – boundary conditions.
 
 oldroyd_theta_scheme.h
 The Oldroyd problem by the theta-scheme – class header.
 
 oldroyd_theta_scheme1.h
 The Oldroyd problem by the theta-scheme – class body.
 
 oldroyd_theta_scheme2.h
 The Oldroyd problem by the theta-scheme – class body.
 
 oldroyd_theta_scheme3.h
 The Oldroyd problem by the theta-scheme – class body.
 
 p_laplacian.h
 The p-Laplacian problem by the Newton method – class header.
 
 p_laplacian1.icc
 The p-Laplacian problem by the Newton method – class body.
 
 p_laplacian2.icc
 The p-Laplacian problem by the Newton method – class body.
 
 p_laplacian_circle.h
 The p-Laplacian problem on a circular geometry – exact solution.
 
 p_laplacian_damped_newton.cc
 The p-Laplacian problem by the damped Newton method.
 
 p_laplacian_error.cc
 The p-Laplacian problem on a circular geometry – error analysis.
 
 p_laplacian_fixed_point.cc
 The p-Laplacian problem by the fixed-point method.
 
 p_laplacian_newton.cc
 The p-Laplacian problem by the Newton method.
 
 p_laplacian_post.cc
 
 phi.h
 The Mossolov problem – the phi function.
 
 poisson_robin.icc
 The Poisson problem with Robin boundary condition – solver function.
 
 proj_band.cc
 The banded level set method - projection on the surface.
 
 projection.h
 The projection for yield-stress rheologies e.g. the yield slip problem.
 
 reconstruction_hho.cc
 The hybrid high order method – reconstruction operator.
 
 reconstruction_hho_check.cc
 residue check
 
 reconstruction_hho_v2.cc
 The hybrid high order method – reconstruction operator.
 
 robin.cc
 The Poisson problem with Robin boundary condition.
 
 robin2.cc
 The Poisson problem with Robin boundary condition.
 
 robin2_lazy.cc
 The Poisson problem with Robin boundary condition.
 
 rotating-hill-statio.h
 
 rotating-hill.h
 Convection-diffusion equation – the rotating hill benchmark.
 
 runge_kutta_semiimplicit.icc
 The semi-implicit Runge-Kutta scheme – coefficients.
 
 runge_kutta_ssp.icc
 The strong stability preserving Runge-Kutta scheme – coefficients.
 
 sgn.icc
 The sign function.
 
 sinusprod.h
 The sinus product function.
 
 sinusprod_dirichlet.h
 The sinus product function – right-hand-side and boundary condition for the Poisson problem.
 
 sinusprod_error.cc
 The cosinus product function – error analysis for the Poisson problem.
 
 sinusprod_error_dg.cc
 The cosinus product function – error analysis for the discontinuous Galerkin method.
 
 sinusprod_error_hdg.cc
 The sinus product function – error analysis for the hybrid discontinuous Galerkin method.
 
 sinusprod_error_hdg_average.cc
 The sinus product function – error analysis for the hybrid discontinuous Galerkin method.
 
 sinusprod_error_hdg_post_rt.cc
 The sinus product function – error analysis for the hybrid discontinuous Galerkin method.
 
 sinusprod_error_hho_reconstruction.cc
 The sinus product function – reconstruction for the hybrid high order method.
 
 sinusprod_grad.h
 The sinus product function – its gradient.
 
 sinusprod_helmholtz.h
 The sinus product function – right-hand-side and boundary condition for the Helmholtz problem.
 
 sinusprod_laplace.h
 The sinus product function – right-hand-side and boundary condition for the Poisson problem with Neumann boundary condition.
 
 sinusrad.h
 The sinus radius function.
 
 sinusrad_error.cc
 The cosinus product function – error analysis for the Poisson problem.
 
 sinusrad_laplace.h
 The sinus radius function – right-hand-side and boundary condition for the Poisson problem with Neumann boundary condition.
 
 sphere.icc
 The level set function for the sphere geometry.
 
 stokes_cavity.cc
 The Stokes problem on the driven cavity benchmark – the Taylor-Hood element.
 
 stokes_cavity_3d.cc
 The Stokes problem on the driven cavity benchmark – the Taylor-Hood element.
 
 stokes_cavity_check.cc
 
 stokes_cavity_incompressible.cc
 
 stokes_contraction.cc
 The Stokes problem on the contraction benchmark – the Taylor-Hood element.
 
 stokes_contraction_bubble.cc
 The Stokes problem on the driven cavity benchmark – the P1-bubble element.
 
 stokes_contraction_bubble_old.cc
 
 stokes_contraction_incompressible.cc
 
 stokes_couette_slip_error.cc
 
 stokes_couette_slip_regul.cc
 
 stokes_dirichlet_dg.icc
 The Stokes problem with Dirichlet boundary condition by the discontinuous Galerkin method – solver function.
 
 stokes_obstacle_slip.cc
 
 stokes_obstacle_slip_regul.cc
 The Stokes problem on the obstacle benchmark with slip boundary condition – the Taylor-Hood element.
 
 stokes_taylor_dg.cc
 The Stokes problem for the Taylor benchmark by the discontinuous Galerkin method.
 
 stokes_taylor_error_dg.cc
 The Stokes problem for the Taylor benchmark by the discontinuous Galerkin method – error analysis.
 
 streamf_cavity.cc
 The stream function for the driven cavity benchmark.
 
 streamf_cavity.icc
 The stream function for the 3D driven cavity benchmark.
 
 streamf_contraction.cc
 The stream function for the contraction benchmark.
 
 streamf_obstacle_slip_move.cc
 The stream function for the obstacle benchmark with slip boundary condition.
 
 stress.cc
 The stress tensor for the linear elasticity and Stokes problems.
 
 taylor.h
 The Taylor benchmark – right-hand-side and boundary condition.
 
 taylor_exact.h
 The Taylor benchmark – the exact solution of the Stokes problem.
 
 torus.icc
 The torus benchmark – level set, right-hand-side and exact solution.
 
 transmission-mixed.cc
 The transmission problem – mixed formulation.
 
 transmission.cc
 The transmission problem.
 
 transmission_dg.cc
 The transmission problem with discontinuous Galerkin method.
 
 transmission_error.cc
 
 transport_dg.cc
 The transport benchmark by the discontinuous Galerkin method.
 
 transport_dg2.cc
 
 transport_dg2.h
 The rotating hill benchmark for the transport problem.
 
 transport_dg2_error.cc
 
 transport_dg_error.cc
 
 transport_hdg.cc
 
 transport_tensor_dg.cc
 The tensorial transport benchmark by the discontinuous Galerkin method.
 
 transport_tensor_error_dg.cc
 The tensorial transport benchmark – error computation.
 
 transport_tensor_exact.icc
 The tensorial transport benchmark – right-hand-side and exact solution.
 
 vector_projection.h
 The projection for yield-stress rheologies – vector-valued case for the Mossolov problem.
 
 vortex_position.cc
 The stream function minima and its position.
 
 vorticity.cc
 The vorticity associated to a vector field.
 
 yield_slip.h
 The yield slip problem – class header.
 
 yield_slip1.icc
 The yield slip problem – class body.
 
 yield_slip2.icc
 The yield slip problem – class body.
 
 yield_slip_augmented_lagrangian.cc
 The yield slip problem by the augmented Lagrangian method.
 
 yield_slip_augmented_lagrangian.icc
 The yield slip problem by the augmented Lagrangian method – solver function.
 
 yield_slip_circle.h
 The yield slip problem on a circle – exact solution.
 
 yield_slip_damped_newton.cc
 The yield slip problem by the damped Neton method.
 
 yield_slip_error.cc
 The yield slip problem on a circle – error computation.
 
 yield_slip_residue.cc
 The yield slip problem – residue computation.
 
 zalesak.h
 The Zalesak slotted disk benchmark – the exact solution.
 
 zalesak_circle.h
 The Zalesak full disk benchmark – the exact solution.
 
 zalesak_circle_dg.cc
 The Zalesak slotted disk benchmark by the discontinuous Galerkin method.
 
 zalesak_circle_dg_error.cc
 The Zalesak slotted disk benchmark – error analysis.
 
 zalesak_dg.cc
 The Zalesak slotted disk benchmark by the discontinuous Galerkin method.
 
 zalesak_dg_adapt.cc
 The Zalesak slotted disk benchmark – adaptive post-treatment.
 
 zalesak_dg_error.cc
 The Zalesak slotted disk benchmark – error analysis.
 
 zalesak_show.cc