| ▼ src |  | 
| ► getfem |  | 
| bgeot_comma_init.h | Convenient initialization of vectors via overload of "operator," | 
| bgeot_config.h | Defines and typedefs for namespace bgeot | 
| bgeot_convex.h | Convex objects (structure + vertices) | 
| bgeot_convex_ref.h | Reference convexes | 
| bgeot_convex_structure.h | Definition of convex structures | 
| bgeot_ftool.h | "File Tools" | 
| bgeot_geometric_trans.h | Geometric transformations on convexes | 
| bgeot_geotrans_inv.h | Inversion of geometric transformations | 
| bgeot_kdtree.h | Simple implementation of a KD-tree | 
| bgeot_mesh.h | Basic mesh definition | 
| bgeot_mesh_structure.h | Mesh structure definition | 
| bgeot_node_tab.h | Structure which dynamically collects points identifying points that are nearer than a certain very small distance | 
| bgeot_permutations.h |  | 
| bgeot_poly.h | Multivariate polynomials | 
| bgeot_poly_composite.h | Handle composite polynomials | 
| bgeot_rtree.h | Region-tree for window/point search on a set of rectangles | 
| bgeot_small_vector.h | Small (dim < 8) vectors | 
| bgeot_sparse_tensors.h | Sparse tensors, used during the assembly | 
| bgeot_tensor.h | Tensor class, used in mat_elem computations | 
| bgeot_torus.h | Provides mesh of torus | 
| dal_backtrace.h | Get debug information | 
| dal_basic.h | Dynamic array class | 
| dal_bit_vector.h | Provide a dynamic bit container | 
| dal_config.h | Defines and typedefs for namespace dal | 
| dal_naming_system.h | Naming system | 
| dal_singleton.h | A simple singleton implementation | 
| dal_static_stored_objects.h | Stores interdependent getfem objects | 
| dal_tas.h | Heap implementation | 
| dal_tree_sorted.h | Balanced tree stored in a dal::dynamic_array | 
| getfem_accumulated_distro.h | Distribution of assembly results (matrices/vectors) for parallel assembly | 
| getfem_arch_config.h |  | 
| getfem_assembling.h | Miscelleanous assembly routines for common terms. Use the low-level generic assembly. Prefer the high-level one | 
| getfem_assembling_tensors.h | Generic assembly implementation | 
| getfem_config.h | Defines and typedefs for namespace getfem | 
| getfem_contact_and_friction_common.h | Comomon tools for unilateral contact and Coulomb friction bricks | 
| getfem_contact_and_friction_integral.h | Unilateral contact and Coulomb friction condition brick | 
| getfem_contact_and_friction_large_sliding.h |  | 
| getfem_contact_and_friction_nodal.h | Unilateral contact and Coulomb friction condition brick | 
| getfem_context.h | Deal with interdependencies of objects (getfem::context_dependencies) | 
| getfem_continuation.h | Inexact Moore-Penrose continuation method | 
| getfem_convect.h | Compute the convection of a quantity with respect to a vector field | 
| getfem_copyable_ptr.h | A smart pointer that copies the value it points to on copy operations | 
| getfem_crack_sif.h | Crack support functions for computation of SIF (stress intensity factors) | 
| getfem_deformable_mesh.h | A class adaptor to deform a mesh | 
| getfem_derivatives.h | Compute the gradient of a field on a getfem::mesh_fem | 
| getfem_error_estimate.h | Definition of a posteriori error estimates | 
| getfem_export.h | Export solutions to various formats | 
| getfem_fem.h | Definition of the finite element methods | 
| getfem_fem_global_function.h | Define mesh_fem whose base functions are global function given by the user | 
| getfem_fem_level_set.h | FEM associated with getfem::mesh_fem_level_set objects | 
| getfem_fourth_order.h | Assembly procedures and bricks for fourth order pdes | 
| getfem_generic_assembly.h | A language for generic assembly of pde boundary value problems | 
| getfem_generic_assembly_compile_and_exec.h |  | 
| getfem_generic_assembly_functions_and_operators.h |  | 
| getfem_generic_assembly_semantic.h | Semantic analysis of assembly trees and semantic manipulations | 
| getfem_generic_assembly_tree.h | Compilation and execution operations | 
| getfem_global_function.h | Definition of global functions to be used as base or enrichment functions in fem | 
| getfem_HHO.h | Tools for Hybrid-High-Order methods | 
| getfem_im_data.h | Provides indexing of integration points for mesh_im | 
| getfem_im_list.h | This file is generated by cubature/make_getfem_list | 
| getfem_import.h | Import mesh files from various formats | 
| getfem_integration.h | Integration methods (exact and approximated) on convexes | 
| getfem_interpolated_fem.h | FEM which interpolates a mesh_fem on a different mesh | 
| getfem_interpolation.h | Interpolation of fields from a mesh_fem onto another | 
| getfem_level_set.h | Define level-sets | 
| getfem_level_set_contact.h | Non frictional level set based large sliding contact; for details see: A. Andreykiv et al. A level set based large sliding contact algorithm for an easy analysis of implant positioning 2012 International Journal for Numerical Methods in Engineering, 89, pp. 1317-1336 2D and 3D Examples of the usage: test_contact.cpp | 
| getfem_linearized_plates.h | Reissner-Mindlin plate model brick | 
| getfem_locale.h | Thread safe standard locale with RAII semantics | 
| getfem_mat_elem.h | Elementary computations (used by the generic assembly) | 
| getfem_mat_elem_type.h | Build elementary tensors descriptors, used by generic assembly | 
| getfem_mesh.h | Define a getfem::getfem_mesh object | 
| getfem_mesh_fem.h | Define the getfem::mesh_fem class | 
| getfem_mesh_fem_global_function.h | Define a mesh_fem with base functions which are global functions given by the user | 
| getfem_mesh_fem_level_set.h | Subclass of mesh_fem which is conformal to a number of level sets | 
| getfem_mesh_fem_product.h | A kind of product of two mesh_fems. Specific for Xfem enrichment | 
| getfem_mesh_fem_sum.h | Implement a special mesh_fem with merges the FEMs of two (or more) mesh_fems | 
| getfem_mesh_im.h | Define the getfem::mesh_im class (integration of getfem::mesh_fem) | 
| getfem_mesh_im_level_set.h | Subclass of mesh_im which is conformal to a number of level sets | 
| getfem_mesh_level_set.h | Keep informations about a mesh crossed by level-sets | 
| getfem_mesh_region.h | Region objects (set of convexes and/or convex faces) | 
| getfem_mesh_slice.h | Define the class getfem::stored_mesh_slice | 
| getfem_mesh_slicers.h | Define various mesh slicers | 
| getfem_mesher.h | An experimental mesher | 
| getfem_model_solvers.h | Standard solvers for model bricks | 
| getfem_models.h | Model representation in Getfem | 
| getfem_Navier_Stokes.h | Navier-Stokes dynamic brick | 
| getfem_nonlinear_elasticity.h | Non-linear elasticty and incompressibility bricks | 
| getfem_omp.h | Tools for multithreaded, OpenMP and Boost based parallelization | 
| getfem_partial_mesh_fem.h | Subclass of getfem::mesh_fem which allows to eliminate a number of dof of the original mesh_fem | 
| getfem_plasticity.h | Plasticty bricks | 
| getfem_projected_fem.h | FEM which projects a mesh_fem on a different mesh | 
| getfem_regular_meshes.h | Build regular meshes | 
| getfem_torus.h | Provides mesh and mesh fem of torus | 
| ► gmm |  | 
| gmm.h | Include common gmm files | 
| gmm_algobase.h | Miscelleanous algorithms on containers | 
| gmm_arch_config.h |  | 
| gmm_blas.h | Basic linear algebra functions | 
| gmm_blas_interface.h | Gmm interface for fortran BLAS | 
| gmm_condition_number.h | Computation of the condition number of dense matrices | 
| gmm_conjugated.h | Handle conjugation of complex matrices/vectors | 
| gmm_def.h | Basic definitions and tools of GMM | 
| gmm_dense_Householder.h | Householder for dense matrices | 
| gmm_dense_lu.h | LU factorizations and determinant computation for dense matrices | 
| gmm_dense_matrix_functions.h | Common matrix functions for dense matrices | 
| gmm_dense_qr.h | Dense QR factorization | 
| gmm_dense_sylvester.h | Sylvester equation solver | 
| gmm_domain_decomp.h | Domain decomposition | 
| gmm_except.h | Definition of basic exceptions | 
| gmm_feedback_management.h | Support for run time management of trace, warning and assert feedback | 
| gmm_inoutput.h | Input/output on sparse matrices | 
| gmm_interface.h | Gmm interface for STL vectors | 
| gmm_interface_bgeot.h | Interface for bgeot::small_vector | 
| gmm_iter.h | Iteration object | 
| gmm_iter_solvers.h | Include standard gmm iterative solvers (cg, gmres, ...) | 
| gmm_kernel.h | Include the base gmm files | 
| gmm_lapack_interface.h | Gmm interface for LAPACK | 
| gmm_least_squares_cg.h |  | 
| gmm_matrix.h | Declaration of some matrix types (gmm::dense_matrix, gmm::row_matrix, gmm::col_matrix, gmm::csc_matrix, etc.) | 
| gmm_modified_gram_schmidt.h | Modified Gram-Schmidt orthogonalization | 
| gmm_MUMPS_interface.h | Interface with MUMPS (LU direct solver for sparse matrices) | 
| gmm_opt.h | Optimization for some small cases (inversion of 2x2 matrices etc.) | 
| gmm_precond.h | Gmm preconditioners | 
| gmm_precond_diagonal.h | Diagonal matrix preconditoner | 
| gmm_precond_ildlt.h | Incomplete Level 0 ILDLT Preconditioner | 
| gmm_precond_ildltt.h | Incomplete LDL^t (cholesky) preconditioner with fill-in and threshold | 
| gmm_precond_ilu.h | Incomplete LU without fill-in Preconditioner | 
| gmm_precond_ilut.h | ILUT: Incomplete LU with threshold and K fill-in Preconditioner | 
| gmm_precond_ilutp.h | ILUTP: Incomplete LU with threshold and K fill-in Preconditioner and column pivoting | 
| gmm_precond_mr_approx_inverse.h | Approximate inverse via MR iteration | 
| gmm_range_basis.h | Extract a basis of the range of a (large sparse) matrix from the columns of this matrix | 
| gmm_real_part.h | Extract the real/imaginary part of vectors/matrices | 
| gmm_ref.h | Provide some simple pseudo-containers | 
| gmm_scaled.h | Get a scaled view of a vector/matrix | 
| gmm_solver_bfgs.h | Implements BFGS (Broyden, Fletcher, Goldfarb, Shanno) algorithm | 
| gmm_solver_bicgstab.h | BiCGStab iterative solver | 
| gmm_solver_cg.h | Conjugate gradient iterative solver | 
| gmm_solver_constrained_cg.h | Constrained conjugate gradient | 
| gmm_solver_gmres.h | GMRES (Generalized Minimum Residual) iterative solver | 
| gmm_solver_idgmres.h | Implicitly restarted and deflated Generalized Minimum Residual | 
| gmm_solver_qmr.h | Quasi-Minimal Residual iterative solver | 
| gmm_solver_Schwarz_additive.h |  | 
| gmm_std.h | Basic setup for gmm (includes, typedefs etc.) | 
| gmm_sub_index.h | Sub-indices | 
| gmm_sub_matrix.h | Generic sub-matrices | 
| gmm_sub_vector.h | Generic sub-vectors | 
| gmm_superlu_interface.h | Interface with SuperLU (LU direct solver for sparse matrices) | 
| gmm_transposed.h | Generic transposed matrices | 
| gmm_tri_solve.h | Solve triangular linear system for dense matrices | 
| gmm_vector.h | Declaration of the vector types (gmm::rsvector, gmm::wsvector, gmm::slvector ,..) | 
| gmm_vector_to_matrix.h | View vectors as row or column matrices | 
| bgeot_convex_ref.cc |  | 
| bgeot_convex_ref_simplexified.cc |  | 
| bgeot_convex_structure.cc |  | 
| bgeot_ftool.cc |  | 
| bgeot_geometric_trans.cc |  | 
| bgeot_geotrans_inv.cc |  | 
| bgeot_kdtree.cc |  | 
| bgeot_mesh_structure.cc |  | 
| bgeot_node_tab.cc |  | 
| bgeot_poly.cc |  | 
| bgeot_poly_composite.cc |  | 
| bgeot_rtree.cc |  | 
| bgeot_small_vector.cc |  | 
| bgeot_sparse_tensors.cc |  | 
| bgeot_torus.cc |  | 
| dal_backtrace.cc |  | 
| dal_bit_vector.cc |  | 
| dal_singleton.cc |  | 
| dal_static_stored_objects.cc |  | 
| getfem_assembling_tensors.cc |  | 
| getfem_contact_and_friction_common.cc |  | 
| getfem_contact_and_friction_integral.cc |  | 
| getfem_contact_and_friction_large_sliding.cc |  | 
| getfem_contact_and_friction_nodal.cc |  | 
| getfem_context.cc |  | 
| getfem_continuation.cc | Inexact Moore-Penrose continuation method | 
| getfem_enumeration_dof_para.cc |  | 
| getfem_error_estimate.cc |  | 
| getfem_export.cc |  | 
| getfem_fem.cc | Implementation of various finite elements | 
| getfem_fem_composite.cc |  | 
| getfem_fem_global_function.cc |  | 
| getfem_fem_level_set.cc | FEM which should be used with getfem::mesh_fem_level_set | 
| getfem_fourth_order.cc |  | 
| getfem_generic_assembly_compile_and_exec.cc |  | 
| getfem_generic_assembly_functions_and_operators.cc |  | 
| getfem_generic_assembly_interpolation.cc |  | 
| getfem_generic_assembly_semantic.cc |  | 
| getfem_generic_assembly_tree.cc |  | 
| getfem_generic_assembly_workspace.cc |  | 
| getfem_global_function.cc |  | 
| getfem_HHO.cc |  | 
| getfem_im_data.cc |  | 
| getfem_import.cc |  | 
| getfem_integration.cc |  | 
| getfem_integration_composite.cc |  | 
| getfem_interpolated_fem.cc |  | 
| getfem_interpolation.cc |  | 
| getfem_interpolation_on_deformed_domains.cc |  | 
| getfem_level_set.cc |  | 
| getfem_level_set_contact.cc |  | 
| getfem_linearized_plates.cc |  | 
| getfem_locale.cc |  | 
| getfem_mat_elem.cc |  | 
| getfem_mat_elem_type.cc |  | 
| getfem_mesh.cc |  | 
| getfem_mesh_fem.cc |  | 
| getfem_mesh_fem_global_function.cc |  | 
| getfem_mesh_fem_level_set.cc |  | 
| getfem_mesh_fem_product.cc |  | 
| getfem_mesh_fem_sum.cc |  | 
| getfem_mesh_im.cc |  | 
| getfem_mesh_im_level_set.cc |  | 
| getfem_mesh_level_set.cc |  | 
| getfem_mesh_region.cc |  | 
| getfem_mesh_slice.cc |  | 
| getfem_mesh_slicers.cc |  | 
| getfem_mesher.cc |  | 
| getfem_model_solvers.cc |  | 
| getfem_models.cc |  | 
| getfem_nonlinear_elasticity.cc |  | 
| getfem_omp.cc |  | 
| getfem_partial_mesh_fem.cc |  | 
| getfem_plasticity.cc |  | 
| getfem_projected_fem.cc |  | 
| getfem_regular_meshes.cc |  | 
| getfem_torus.cc |  | 
| ▼ tests |  | 
| elastostatic.cc | Linear Elastostatic problem | 
| helmholtz.cc | Helmholtz problem (Delta(u) + k^2 u = 0) | 
| laplacian.cc | Laplacian (Poisson) problem | 
| nonlinear_elastostatic.cc | Nonlinear Elastostatic problem (large strain) | 
| plasticity.cc | Small deformation plasticity problem | 
| plate.cc | Linear Elastostatic plate problem | 
| stokes.cc | Solve the stokes problem (incompressible viscuous fluid) |