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