Rheolef
7.2
an efficient C++ finite element environment
|
▼ build | |
▼ rheolef-6JaqjL | |
▼ rheolef-7.2 | |
▼ config | |
acconfig.h | |
compiler_eigen.h | |
compiler_mpi.h | |
config.h | |
Float.h | Float - default floating point |
rheolef-config.in | rheolef-config - get installation directories |
▼ doc | |
► examples | |
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 | |
web | |
▼ fem | |
► geo_element | |
cgal_kernel.h | |
cgal_kernel_float128.h | |
cgal_traits.h | |
cxx_reference_element.cc | |
edge.icc | edge - reference element |
field_expr_utilities.h | |
geo_element.cc | |
geo_element.h | geo_element - geometrical element of a mesh |
geo_element_aux.icc | |
geo_element_indirect.cc | |
geo_element_indirect.h | |
hexahedron.icc | hexahedron - reference element |
integrate_option.h | integrate_option - expression integration options |
point.cc | |
point.h | point - d-dimensional physical point or vector |
point.icc | point - reference element |
point_predicate.cc | |
prism.icc | prism - reference element |
quadrangle.icc | quadrangle - reference element |
quadrature.cc | quadrature - show a quadrature formula |
quadrature.h | |
quadrature_e.cc | |
quadrature_H.cc | |
quadrature_p.cc | |
quadrature_Pr.cc | |
quadrature_q.cc | |
quadrature_rep.cc | |
quadrature_t.cc | |
quadrature_Te.cc | |
reference_element.cc | |
reference_element.h | reference_element - reference element |
reference_element_aux.icc | |
reference_element_declare.cc | |
reference_element_face_transformation.cc | |
reference_element_face_transformation.h | |
space_constant.cc | |
space_constant.h | |
stamp-symlink.in | |
tensor-exp.cc | |
tensor.cc | |
tensor.h | tensor - d-dimensional physical tensor |
tensor3.cc | |
tensor3.h | tensor3 - d-dimensional physical third-order tensor |
tensor4-dexp.cc | |
tensor4.cc | |
tensor4.h | tensor4 - d-dimensional physical fourth-order tensor |
tetrahedron.icc | tetrahedron - reference element |
tiny_element.cc | |
tiny_element.h | |
tiny_lu.h | |
tiny_matvec.h | |
triangle.icc | triangle - reference element |
undeterminated.h | |
► lib | |
ad3.h | |
basis.cc | basis - plot a finite element basis |
basis.h | basis - finite element method |
basis_fem_empty.cc | |
basis_fem_empty.h | |
basis_fem_Pk_bernstein.cc | |
basis_fem_Pk_bernstein.h | |
basis_fem_Pk_lagrange.cc | |
basis_fem_Pk_lagrange.h | |
basis_fem_Pk_sherwin.cc | |
basis_fem_Pk_sherwin.h | |
basis_fem_RTk.cc | |
basis_fem_RTk.h | |
basis_fem_tensor.cc | |
basis_fem_tensor.h | |
basis_fem_trace_n.cc | |
basis_fem_trace_n.h | |
basis_fem_vector.cc | |
basis_fem_vector.h | |
basis_fem_visu_gnuplot.cc | |
basis_get.cc | |
basis_get.h | |
basis_list.cc | |
basis_on_pointset.cc | |
basis_on_pointset.h | |
basis_on_pointset_evaluate.icc | |
basis_option.cc | |
basis_option.h | basis_option - finite element method options |
basis_ordering.icc | |
basis_raw.cc | |
basis_raw.h | |
basis_raw_bernstein.cc | |
basis_raw_bernstein.h | |
basis_raw_dubiner.cc | |
basis_raw_dubiner.h | |
basis_raw_list.cc | |
basis_raw_monomial.cc | |
basis_raw_monomial.h | |
basis_raw_visu_gnuplot.cc | |
basis_rep.cc | |
basis_symbolic.cc | |
basis_symbolic.h | |
basis_symbolic_cxx.cc | |
basis_visu_gnuplot.icc | |
bernstein.icc | |
bubble.cc | |
bubble.h | |
bubble_symbolic.cc | |
dubiner.icc | |
eigen_util.h | |
equispaced.icc | |
fekete.icc | |
interpolate_RTk_polynom.icc | |
memorized_value.h | |
monomial.icc | |
P0.cc | |
P0.h | |
P0_symbolic.cc | |
P1.cc | |
P1.h | |
P1_symbolic.cc | |
P1qd.cc | |
P1qd.h | |
P1qd_symbolic.cc | |
piola.h | |
piola_fem.h | |
piola_fem_grad_post.icc | |
piola_fem_hdiv.cc | |
piola_fem_hdiv.h | |
piola_fem_lagrange.cc | |
piola_fem_lagrange.h | |
Pk_get_local_idof_on_side.icc | |
pointset.h | |
pointset_option.h | |
reference_element_aux.icc | |
set_simplex_leb_gll.cc | |
sherwin.icc | |
stamp-symlink.in | |
warburton.icc | |
► quadrature | |
gamma.h | |
gamma.icc | |
gauss_chebyschev.h | |
gauss_chebyschev.icc | |
gauss_chebyschev_check.h | |
gauss_chebyschev_check.icc | |
gauss_jacobi.h | |
gauss_jacobi.icc | |
gauss_jacobi_check.h | |
gauss_jacobi_check.icc | |
gauss_legendre_check.h | |
gauss_legendre_check.icc | |
gauss_lobatto_chebyschev.h | |
gauss_lobatto_chebyschev.icc | |
gauss_lobatto_jacobi.h | |
gauss_lobatto_jacobi.icc | |
gauss_radau_chebyschev.h | |
gauss_radau_chebyschev.icc | |
gauss_radau_jacobi.h | |
gauss_radau_jacobi.icc | |
jacobi.h | |
jacobi.icc | |
jacobi_roots.h | |
jacobi_roots.icc | |
stamp-symlink.in | |
▼ linalg | |
► bin | |
csr.cc | csr - sparse matrix manipulation |
► lib | |
asr.cc | |
asr.h | |
asr_to_csr.h | |
asr_to_csr_dist_logical.h | |
cg.h | cg - conjugate gradient algorithm |
communicator.h | communicator - MPI communicator for C++ |
csr.cc | |
csr.h | csr - distributed compressed sparse matrix |
csr_amux.h | |
csr_concat.cc | |
csr_concat.h | |
csr_cumul_trans_mult.h | |
csr_mpi.cc | |
csr_seq.cc | |
csr_to_asr.h | |
csr_vec_expr.h | |
dia.h | |
diag.h | |
dis_accumulate.h | |
dis_cpu_time.cc | |
dis_cpu_time.h | dis_cpu_time - cumulated cpu for distributed computations |
dis_inner_product.h | |
dis_macros.h | |
dis_memory_usage.cc | |
dis_memory_usage.h | dis_memory_usage - memory used in distributed environment |
disarray.h | disarray - distributed container |
disarray_mpi.icc | |
disarray_mpi_inst.cc | |
disarray_seq.icc | |
disarray_seq_inst.cc | |
disarray_store.h | |
distributor.cc | |
distributor.h | distributor - memory distribution table |
diststream.cc | |
diststream.h | diststream - i/o streams in distributed environment |
environment.cc | |
environment.h | environment - initialization of distributed computations |
expr_utilities.h | |
eye.h | eye - identity matrix and preconditionner |
functional_sgi_ext.h | |
get_pointer_from_iterator.h | |
gmres.h | gmres - generalized minimum residual algorithm |
ilut.cc | |
ilut.h | ilut - incomplete LU factorization preconditionner |
index_set.cc | |
index_set.h | |
index_set_body.icc | |
index_set_header.icc | |
linalg.h | |
load_chunk.h | |
mic.cc | |
mic.h | mic - modified incomplete Cholesky factorization preconditionner |
minres.h | minres - minimum residual algorithm |
mixed_solver.h | |
mm_io.cc | |
mm_io.h | |
mpi_assembly_begin.h | |
mpi_assembly_end.h | |
mpi_pair_datatype.h | |
mpi_scatter_begin.h | |
mpi_scatter_end.h | |
mpi_scatter_init.h | |
mpi_scatter_map.h | |
msg_both_permutation_apply.h | |
msg_from_context_indices.h | |
msg_from_context_pattern.h | |
msg_left_permutation_apply.h | |
msg_local_context.h | |
msg_local_optimize.h | |
msg_right_permutation_apply.h | |
msg_sort_with_permutation.h | |
msg_to_context.h | |
msg_util.h | |
pair_set.h | |
range.h | range - index range for a subset of a vector |
scalar_traits.h | |
scatter_message.h | |
scatter_message.icc | |
solver.cc | |
solver.h | solver - direct and iterative solver |
solver_abtb.cc | |
solver_abtb.h | solver_abtb - mixed systems solver |
solver_cholmod.cc | |
solver_cholmod.h | |
solver_eigen.cc | |
solver_eigen.h | |
solver_gmres_cg.cc | |
solver_gmres_cg.h | |
solver_mumps.cc | |
solver_mumps.h | |
solver_option.cc | |
solver_option.h | solver_option - direct and iterative solver options |
solver_pastix.h | |
solver_pastix_mpi.cc | |
solver_pastix_seq.cc | |
solver_trilinos_ifpack.cc | |
solver_trilinos_ifpack.h | |
solver_umfpack.cc | |
solver_umfpack.h | |
stamp-symlink.in | |
uzawa.h | |
vec.h | vec - distributed vector |
vec_concat.cc | |
vec_concat.h | |
vec_expr_v2.h | |
vec_range.h | |
vector_of_iterator.h | |
▼ main | |
► bin | |
branch.cc | branch - handle a family of fields |
field.cc | field - plot a field |
geo.cc | geo - plot a finite element mesh |
► lib | |
adapt.cc | |
adapt.h | adapt - adaptive mesh generation |
adapt_bamg.cc | |
adapt_gmsh.cc | |
band.cc | |
band.h | band - banded level set method |
branch.cc | |
branch.h | branch - parameter-dependent sequence of field |
branch_seq_get_vtk.cc | |
branch_seq_put_vtk.cc | |
branch_seq_visu_gnuplot.cc | |
branch_seq_visu_vtk_paraview.cc | |
characteristic.cc | |
characteristic.h | characteristic - Lagrange-Galerkin method |
compose.h | compose - n-ary function application in expressions |
continuation.h | continuation - nonlinear solver |
continuation_option.h | continuation_option - continuation solver options |
continuation_step.h | |
damped-newton-generic.h | |
damped_newton.h | damped_newton - nonlinear solver |
domain_indirect.h | |
domain_indirect_mpi.cc | |
domain_indirect_seq.cc | |
element_constant.h | |
expression.h | expression - involved by interpolate and integrate |
fem_on_pointset.cc | |
fem_on_pointset.h | |
field.cc | |
field.h | field - piecewise polynomial finite element function |
field_concat.cc | |
field_concat.h | |
field_concept.h | |
field_eigen.h | |
field_evaluate.cc | |
field_evaluate.h | |
field_expr.h | |
field_expr_quadrature.h | |
field_expr_recursive.h | |
field_expr_terminal.cc | |
field_expr_terminal.h | |
field_expr_value_assembly.h | |
field_expr_variational.h | |
field_expr_variational_tag.h | |
field_expr_variational_terminal.h | |
field_functor.h | |
field_lazy.h | field_lazy - field expressions: concept, grammar and class hierarchy |
field_lazy_form_mult.h | |
field_lazy_node.h | |
field_lazy_terminal.h | |
field_rdof.h | |
field_rdof.icc | |
field_rdof_node.h | |
field_seq_put_bamg_bb.cc | |
field_seq_put_gmsh.cc | |
field_seq_put_gmsh_pos.cc | |
field_seq_put_vtk.cc | |
field_seq_visu_gmsh.cc | |
field_seq_visu_gnuplot.cc | |
field_seq_visu_gnuplot_internal.h | |
field_seq_visu_vtk_paraview.cc | |
field_valarray.h | |
field_vf_assembly.h | |
field_wdof.h | |
field_wdof.icc | |
field_wdof_convert.h | |
field_wdof_indirect.h | |
field_wdof_sliced.h | |
form.cc | |
form.h | form - finite element bilinear form |
form_concat.cc | |
form_concat.h | |
form_expr_quadrature.h | |
form_expr_variational.h | |
form_field_expr.h | |
form_lazy_convert.h | |
form_lazy_expr.h | form_lazy_expr - form expressions: concept and class hierarchy |
form_lazy_terminal.h | |
form_vf_assembly.cc | |
form_vf_assembly.h | |
form_weighted.h | |
functor.h | |
geo.cc | |
geo.h | geo - finite element mesh |
geo_build_from_list.cc | |
geo_build_zero_dim.cc | |
geo_domain.cc | |
geo_domain.h | |
geo_domain_indirect.cc | |
geo_domain_indirect.h | |
geo_domain_indirect_mpi.cc | |
geo_domain_indirect_seq.cc | |
geo_domain_mpi.cc | |
geo_domain_seq.cc | |
geo_element_contains.cc | |
geo_element_contains.h | |
geo_element_curved_ball.h | |
geo_header.cc | |
geo_header.h | |
geo_locate.cc | |
geo_locate.h | |
geo_mpi.cc | |
geo_mpi_dual.cc | |
geo_mpi_get.cc | |
geo_mpi_partition.cc | |
geo_mpi_partition_scotch.cc | |
geo_mpi_put.cc | |
geo_nearest.cc | |
geo_nearest.h | |
geo_neighbour.cc | |
geo_partition_scotch.h | |
geo_seq_check.cc | |
geo_seq_get.cc | |
geo_seq_get_bamg.cc | |
geo_seq_get_vtk.cc | |
geo_seq_put.cc | |
geo_seq_put_bamg.cc | |
geo_seq_put_gmsh.cc | |
geo_seq_put_vtk.cc | |
geo_seq_put_vtk.h | |
geo_seq_upgrade.cc | |
geo_seq_visu_gnuplot.cc | |
geo_seq_visu_vtk_paraview.cc | |
geo_size.cc | |
geo_size.h | |
geo_subdivide.cc | |
geo_trace_move.cc | |
geo_trace_ray_boundary.cc | |
geo_trace_ray_boundary.h | |
hack_array.h | |
hack_array_mpi.icc | |
hack_array_seq.icc | |
init_expr_quadrature.h | |
integrate.h | integrate - expression integration |
integrate_numeric.icc | |
interpolate.cc | |
interpolate.h | interpolate - function or expression interpolation |
inv_piola.h | |
iofem.cc | |
iofem.h | |
keller.h | |
keller_details.h | |
level_set.cc | |
level_set.h | level_set - zero level set of a field |
limiter.cc | |
limiter.h | limiter - discontinuous Galerkin slope limiter |
memorized_disarray.h | |
newton-backtrack.h | |
newton.h | newton - nonlinear solver |
newton_add_missing.h | |
pair_with_linear_algebra.h | |
piola_on_pointset.cc | |
piola_on_pointset.h | |
piola_util.cc | |
piola_util.h | |
point_util.h | |
problem.h | problem - linear solver |
problem_mixed.h | problem_mixed - linear solver |
render_option.cc | |
render_option.h | |
rheolef.h | rheolef - reference manual |
rheolef_seq.h | |
riesz.h | |
round.h | |
space.cc | |
space.h | space - piecewise polynomial finite element space |
space_component.h | |
space_constitution.cc | |
space_constitution.h | |
space_constitution_assembly.cc | |
space_constitution_get.cc | |
space_constitution_get.icc | |
space_constitution_old_get.cc | |
space_mpi.cc | |
space_mult.h | |
space_numbering.cc | |
space_numbering.h | |
space_seq.cc | |
stamp-symlink.in | |
test.cc | |
test.h | test - test-function in variational formulation |
test_component.h | |
vf_tag.h | |
vtk_cell_type.cc | |
vtk_cell_type.h | |
► sbin | |
bamg2geo.cc | bamg2geo - convert bamg mesh in geo format |
field2bb.cc | |
field2gmsh_pos.cc | |
geo_split.cc | |
mkgeo_ball.sh | mkgeo_ball - unstructured mesh of an ellipsoid |
mkgeo_ball_gmsh_fix.cc | |
mkgeo_contraction.sh | mkgeo_contraction - mesh of an abrupt contraction |
mkgeo_couette.sh | mkgeo_couette - mesh of the Couette geometry |
mkgeo_grid.sh | mkgeo_grid - structured mesh of a parallelepiped |
mkgeo_obstacle.sh | mkgeo_obstacle - mesh of the obstacle-in-channel |
mkgeo_sector.sh | mkgeo_sector - mesh of a sector |
mkgeo_ugrid.sh | mkgeo_ugrid - unstructured mesh of a parallelepiped |
msh2geo.cc | msh2geo - convert gmsh mesh in geo format |
msh2geo_defs.icc | |
msh2geo_node_renum.icc | |
▼ util | |
bamg | |
► lib | |
catchmark.h | catchmark - input/output manipulator |
heap_allocator.h | |
heap_object.h | |
iorheo-members.h | |
iorheo.cc | |
iorheo.h | |
iorheobase.h | |
misc_algo.h | |
pair_util.h | |
persistent_table.h | persistent_table - persistent data base |
pretty_name.cc | |
pretty_name.h | |
promote.h | |
rheostream.cc | |
rheostream.h | rheostream - i/o utilities |
rounder.h | |
scatch.icc | |
smart_pointer.h | smart_pointer - with true copy semantic |
stack_allocator.h | |
stamp-symlink.in | |
Vector.h |