Reference documentation for deal.II version GIT relicensing-136-gb80d0be4af 2024-03-18 08:20:02+00:00
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Todo List
Class Algorithms::OperatorBase
Update this documentation and the one of Operator
Class AnyData
GK: Deprecate access to AnyData by index and change to a map.
Class BlockInfo
Extend the functions local() and renumber() to allow for hp-capablilites.
Class BlockSparsityPatternBase< SparsityPatternType >
Handle optimization of diagonal elements of the underlying SparsityPattern correctly.
Class DataOutFaces< dim, spacedim >
Reimplement this whole class using actual FEFaceValues and MeshWorker.
Member DataOutFaces< dim, spacedim >::build_patches (const Mapping< dim, spacedim > &mapping, const unsigned int n_subdivisions=0)
The mapping argument should be replaced by a hp::MappingCollection in case of a DoFHandler with hp-capabilities.
Class Differentiation::AD::HelperBase< ADNumberTypeCode, ScalarType >
Make this class thread safe for Sacado number and ADOL-C tapeless numbers (if supported).
Member DoFTools::ExcFiniteElementsDontMatch ()
Write description
Member DoFTools::ExcGridNotCoarser ()
Write description
Member DoFTools::ExcGridsDontMatch ()
Write description
Member DoFTools::ExcInvalidBoundaryIndicator ()
Write description
Member DoFTools::map_support_points_to_dofs (const Mapping< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof_handler, std::map< Point< spacedim >, types::global_dof_index, Comp > &point_to_index_map)
This function should generate a multimap, rather than just a map, since several dofs may be located at the same support point. Currently, only the last value in the map returned by map_dofs_to_support_points() for each point will be returned.
Class FE_ABF< dim >
Even if this element is implemented for two and three space dimensions, the definition of the node values relies on consistently oriented faces in 3d. Therefore, care should be taken on complicated meshes.
Class FE_BDM< dim >

The 3d version exhibits some numerical instabilities, in particular for higher order

Restriction matrices are missing.

Class FE_Nedelec< dim >
Even if this element is implemented for two and three space dimensions, the definition of the node values relies on consistently oriented faces in 3d. Therefore, care should be taken on complicated meshes.
Class FE_Poly< dim, spacedim >
Since nearly all functions for spacedim != dim are specialized, this class needs cleaning up.
Class FE_RT_Bubbles< dim >
Implement restriction matrices
Member FESubfaceValues< dim, spacedim >::ExcFaceHasNoSubfaces ()
Document this
Member FESubfaceValues< dim, spacedim >::ExcReinitCalledWithBoundaryFace ()
Document this
Member GinkgoWrappers::SolverBase< ValueType, IndexType >::system_matrix
Templatize based on Matrix type.
Member internal::TriangulationImplementation::TriaObjects::next_free_pair_object (const Triangulation< dim, spacedim > &tria)
This function is not instantiated for the codim-one case
Member internal::TriangulationImplementation::TriaObjects::next_free_single_object (const Triangulation< dim, spacedim > &tria)
This function is not instantiated for the codim-one case
Member LocalIntegrators::Divergence::cell_residual (Vector< number > &result, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< double > > &input, const double factor=1.)
Verify: The function cell_matrix() is the Frechet derivative of this function with respect to the test functions.
Member LocalIntegrators::Divergence::gradient_residual (Vector< number > &result, const FEValuesBase< dim > &fetest, const std::vector< double > &input, const double factor=1.)
Verify: The function gradient_matrix() is the Frechet derivative of this function with respect to the test functions.
Class Mapping< dim, spacedim >
Document what happens in the codimension-1 case.
Member Mapping< dim, spacedim >::transform (const ArrayView< const Tensor< 2, dim > > &input, const MappingKind kind, const typename Mapping< dim, spacedim >::InternalDataBase &internal, const ArrayView< Tensor< 2, spacedim > > &output) const =0
The formulas for mapping_covariant_gradient, mapping_contravariant_gradient and mapping_piola_gradient are only true as stated for linear mappings. If, for example, the mapping is bilinear (or has a higher order polynomial degree) then there is a missing term associated with the derivative of \(J\).
Class MatrixBlock< MatrixType >
Example for the product preconditioner of the pressure Schur complement.
Member MatrixBlock< MatrixType >::add (const std::vector< size_type > &indices, const FullMatrix< number > &full_matrix, const bool elide_zero_values=true)
elide_zero_values is currently ignored.
Member MatrixBlock< MatrixType >::add (const std::vector< size_type > &row_indices, const std::vector< size_type > &col_indices, const FullMatrix< number > &full_matrix, const bool elide_zero_values=true)
elide_zero_values is currently ignored.
Member MatrixBlock< MatrixType >::add (const size_type row_index, const std::vector< size_type > &col_indices, const std::vector< number > &values, const bool elide_zero_values=true)
elide_zero_values is currently ignored.
Member MatrixCreator::create_boundary_mass_matrix (const Mapping< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof, const Quadrature< dim - 1 > &q, SparseMatrix< number > &matrix, const std::map< types::boundary_id, const Function< spacedim, number > * > &boundary_functions, Vector< number > &rhs_vector, std::vector< types::global_dof_index > &dof_to_boundary_mapping, const Function< spacedim, number > *const weight=0, std::vector< unsigned int > component_mapping={})
This function does not work for finite elements with cell-dependent shape functions.
Class MeshWorker::Assembler::MGMatrixSimple< MatrixType >
The matrix structures needed for assembling level matrices with local refinement and continuous elements are missing.
Class MeshWorker::Assembler::ResidualLocalBlocksToGlobalBlocks< VectorType >
Comprehensive model currently not implemented.
Class MeshWorker::DoFInfoBox< dim, DOFINFO >
Currently, we are storing an object for the cells and two for each face. We could gather all face data pertaining to the cell itself in one object, saving a bit of memory and a few operations, but sacrificing some cleanliness.
Class MGTransferBase< VectorType >
update the following documentation, since it does not reflect the latest changes in structure.
Class PathSearch
Add support for environment variables like in kpathsea.
Class PolynomialsAdini< dim >
This polynomial space is implemented in 2d only and does not compute derivatives of order 3 or higher.