From 7129009579853c4f5b5ca4675f313f4923674f75 Mon Sep 17 00:00:00 2001 From: guido Date: Thu, 14 Aug 2003 12:42:24 +0000 Subject: [PATCH] more preparations for doxygen git-svn-id: https://svn.dealii.org/trunk@7920 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/fe/fe.h | 3 + deal.II/deal.II/include/fe/fe_base.h | 4 +- deal.II/deal.II/include/fe/fe_dgp.h | 6 +- .../deal.II/include/fe/fe_dgp_nonparametric.h | 4 + deal.II/deal.II/include/fe/fe_dgq.h | 4 + deal.II/deal.II/include/fe/fe_nedelec.h | 3 + deal.II/deal.II/include/fe/fe_q.h | 3 + .../deal.II/include/fe/fe_q_hierarchical.h | 3 + .../deal.II/include/fe/fe_raviart_thomas.h | 3 + deal.II/deal.II/include/fe/fe_system.h | 4 + deal.II/deal.II/include/fe/fe_tools.h | 5 +- deal.II/deal.II/include/fe/fe_update_flags.h | 5 + deal.II/deal.II/include/fe/fe_values.h | 4 +- deal.II/deal.II/include/fe/mapping.h | 4 + deal.II/deal.II/include/fe/mapping_c1.h | 4 + .../deal.II/include/fe/mapping_cartesian.h | 5 +- deal.II/deal.II/include/fe/mapping_q.h | 3 + deal.II/deal.II/include/fe/mapping_q1.h | 5 + .../deal.II/include/fe/mapping_q1_eulerian.h | 4 + deal.II/deal.II/include/grid/tria.h | 92 ++++++++++++++++++- deal.II/doc/doxygen/headers/deal.II/dox.h | 21 +++++ deal.II/doc/doxygen/headers/lac/dox.h | 22 ++--- 22 files changed, 192 insertions(+), 19 deletions(-) diff --git a/deal.II/deal.II/include/fe/fe.h b/deal.II/deal.II/include/fe/fe.h index 5169361edf..fcbe0e078b 100644 --- a/deal.II/deal.II/include/fe/fe.h +++ b/deal.II/deal.II/include/fe/fe.h @@ -24,6 +24,8 @@ template class FEFaceValues; template class FESubfaceValues; template class FESystem; +/*!@addtogroup febase */ +/*@{*/ /** * Common interface of all finite elements. Here, the functions to @@ -355,5 +357,6 @@ class FiniteElement : public FiniteElementBase friend class FESystem; }; +/*@}*/ #endif diff --git a/deal.II/deal.II/include/fe/fe_base.h b/deal.II/deal.II/include/fe/fe_base.h index 85f16c573d..b3561e90b7 100644 --- a/deal.II/deal.II/include/fe/fe_base.h +++ b/deal.II/deal.II/include/fe/fe_base.h @@ -28,6 +28,8 @@ template class FESystem; +/*!@addtogroup febase */ +/*@{*/ /** @@ -1710,7 +1712,7 @@ class FiniteElementBase : public Subscriptor, */ friend class InternalDataBase; }; - +/*@}*/ template inline diff --git a/deal.II/deal.II/include/fe/fe_dgp.h b/deal.II/deal.II/include/fe/fe_dgp.h index 09c7be6112..b783270100 100644 --- a/deal.II/deal.II/include/fe/fe_dgp.h +++ b/deal.II/deal.II/include/fe/fe_dgp.h @@ -23,6 +23,9 @@ template class PolynomialSpace; template class MappingQ; +/*!@addtogroup fe */ +/*@{*/ + /** * Discontinuous finite elements based on Legendre polynomials. * @@ -458,13 +461,14 @@ class FE_DGP : public FiniteElement template friend class FE_DGP; /** - * Allows @p{MappingQ} class to + * Allows @p{MappingQ} class * access to build_renumbering * function. */ friend class MappingQ; }; +/*@}*/ // declaration of explicit specializations of member variables, if the // compiler allows us to do that (the standard says we must) diff --git a/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h b/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h index 72e594c0f2..479f2b6301 100644 --- a/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h +++ b/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h @@ -22,6 +22,9 @@ template class PolynomialSpace; template class MappingQ; +/*!@addtogroup fe */ +/*@{*/ + /** * Discontinuous finite elements evaluated at the mapped quadrature points. * @@ -437,6 +440,7 @@ class FE_DGPNonparametric : public FiniteElement friend class MappingQ; }; +/*@}*/ // declaration of explicit specializations of member variables, if the // compiler allows us to do that (the standard says we must) diff --git a/deal.II/deal.II/include/fe/fe_dgq.h b/deal.II/deal.II/include/fe/fe_dgq.h index f5cd910154..bb4af0c9fe 100644 --- a/deal.II/deal.II/include/fe/fe_dgq.h +++ b/deal.II/deal.II/include/fe/fe_dgq.h @@ -22,6 +22,9 @@ template class TensorProductPolynomials; template class MappingQ; +/*!@addtogroup fe */ +/*@{*/ + /** * Discontinuous tensor product elements based on equidistant support points. * @@ -512,6 +515,7 @@ class FE_DGQ : public FiniteElement template friend class MappingQ; }; +/*@}*/ // declaration of explicit specializations of member variables, if the // compiler allows us to do that (the standard says we must) diff --git a/deal.II/deal.II/include/fe/fe_nedelec.h b/deal.II/deal.II/include/fe/fe_nedelec.h index 8cb0977a14..4798d225ab 100644 --- a/deal.II/deal.II/include/fe/fe_nedelec.h +++ b/deal.II/deal.II/include/fe/fe_nedelec.h @@ -20,6 +20,8 @@ template class MappingQ; +/*!@addtogroup fe */ +/*@{*/ /** * Implementation of continuous Nedelec elements for the space @@ -608,6 +610,7 @@ class FE_Nedelec : public FiniteElement template friend class FE_Nedelec; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/fe_q.h b/deal.II/deal.II/include/fe/fe_q.h index 66f3627906..c771adee7f 100644 --- a/deal.II/deal.II/include/fe/fe_q.h +++ b/deal.II/deal.II/include/fe/fe_q.h @@ -22,6 +22,8 @@ template class TensorProductPolynomials; template class MappingQ; +/*!@addtogroup fe */ +/*@{*/ /** * Implementation of Lagrange finite elements @p{Qp} that yield the @@ -843,6 +845,7 @@ class FE_Q : public FiniteElement template friend class FE_Q; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/fe_q_hierarchical.h b/deal.II/deal.II/include/fe/fe_q_hierarchical.h index 9823c87351..540fb2a363 100644 --- a/deal.II/deal.II/include/fe/fe_q_hierarchical.h +++ b/deal.II/deal.II/include/fe/fe_q_hierarchical.h @@ -23,6 +23,8 @@ template class TensorProductPolynomials; template class MappingQ; +/*!@addtogroup fe */ +/*@{*/ /** * Implementation of Hierarchical finite elements @p{Qp} that yield the @@ -792,6 +794,7 @@ class FE_Q_Hierarchical : public FiniteElement template friend class FE_Q_Hierarchical; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/fe_raviart_thomas.h b/deal.II/deal.II/include/fe/fe_raviart_thomas.h index 9d88b11fb0..795cdba425 100644 --- a/deal.II/deal.II/include/fe/fe_raviart_thomas.h +++ b/deal.II/deal.II/include/fe/fe_raviart_thomas.h @@ -21,6 +21,8 @@ template class MappingQ; +/*!@addtogroup fe */ +/*@{*/ /** * Implementation of continuous Raviart-Thomas elements for the space @@ -568,6 +570,7 @@ class FE_RaviartThomas : public FiniteElement template friend class FE_RaviartThomas; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/fe_system.h b/deal.II/deal.II/include/fe/fe_system.h index 6a9a557ac7..fc642ca8d5 100644 --- a/deal.II/deal.II/include/fe/fe_system.h +++ b/deal.II/deal.II/include/fe/fe_system.h @@ -23,6 +23,9 @@ #include +/*!@addtogroup febase */ +/*@{*/ + /** * This class provides an interface to group several elements together * into one. To the outside world, the resulting object looks just @@ -897,6 +900,7 @@ class FESystem : public FiniteElement }; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/fe_tools.h b/deal.II/deal.II/include/fe/fe_tools.h index e204ea7a14..fac0190c82 100644 --- a/deal.II/deal.II/include/fe/fe_tools.h +++ b/deal.II/deal.II/include/fe/fe_tools.h @@ -28,6 +28,9 @@ class ConstraintMatrix; #include #include +/*!@addtogroup febase */ +/*@{*/ + /** * This class performs interpolations and extrapolations of discrete * functions of one @p{FiniteElement} @p{fe1} to another @p{FiniteElement} @@ -594,7 +597,7 @@ class FETools get_fe_from_name_aux (const std::string &name); }; - +/*@}*/ /*---------------------------- fe_tools.h ---------------------------*/ /* end of #ifndef __deal2__fe_tools_H */ diff --git a/deal.II/deal.II/include/fe/fe_update_flags.h b/deal.II/deal.II/include/fe/fe_update_flags.h index af13de18c4..639e003ab4 100644 --- a/deal.II/deal.II/include/fe/fe_update_flags.h +++ b/deal.II/deal.II/include/fe/fe_update_flags.h @@ -17,6 +17,9 @@ #include +/*!@addtogroup febase */ +/*@{*/ + /** * Provide a set of flags which tells the @p{FEValues<>::reinit} * function, which fields are to be updated for each cell. E.g. if you @@ -163,4 +166,6 @@ operator & (const UpdateFlags& f1, const UpdateFlags& f2) return result; } +/*@}*/ + #endif diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index 95d108f51d..55a104a4b4 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -33,6 +33,8 @@ template class Quadrature; +/*!@addtogroup febase */ +/*@{*/ /** * Contains all data vectors for @p{FEValues}. @@ -1180,7 +1182,7 @@ class FESubfaceValues : public FEFaceValuesBase void initialize (const UpdateFlags update_flags); }; - +/*@}*/ /*------------------------ Inline functions: FEValuesBase ------------------------*/ diff --git a/deal.II/deal.II/include/fe/mapping.h b/deal.II/deal.II/include/fe/mapping.h index db8e033abf..50c2c3e40a 100644 --- a/deal.II/deal.II/include/fe/mapping.h +++ b/deal.II/deal.II/include/fe/mapping.h @@ -29,6 +29,9 @@ template class FEFaceValues; template class FESubfaceValues; +/*!@addtogroup febase */ +/*@{*/ + /** * Abstract base class for mapping classes. * @@ -524,6 +527,7 @@ class Mapping : public Subscriptor friend class FESubfaceValues; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/mapping_c1.h b/deal.II/deal.II/include/fe/mapping_c1.h index 206eb4c06f..35a48508dd 100644 --- a/deal.II/deal.II/include/fe/mapping_c1.h +++ b/deal.II/deal.II/include/fe/mapping_c1.h @@ -18,6 +18,9 @@ #include +/*!@addtogroup fe */ +/*@{*/ + /** * Mapping class that uses C1 (continuously differentiable) cubic * mappings of the boundary. This class is built atop of @@ -101,6 +104,7 @@ class MappingC1 : public MappingQ std::vector > &a) const; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/mapping_cartesian.h b/deal.II/deal.II/include/fe/mapping_cartesian.h index 2161a1e25e..f6aef565d8 100644 --- a/deal.II/deal.II/include/fe/mapping_cartesian.h +++ b/deal.II/deal.II/include/fe/mapping_cartesian.h @@ -20,6 +20,9 @@ #include +/*!@addtogroup fe */ +/*@{*/ + /** * Mapping of an axis-parallel cell. * @@ -261,7 +264,7 @@ class MappingCartesian : public Mapping static const unsigned int invalid_face_number = static_cast(-1); }; - +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/mapping_q.h b/deal.II/deal.II/include/fe/mapping_q.h index 9071c0cab2..b19964da13 100644 --- a/deal.II/deal.II/include/fe/mapping_q.h +++ b/deal.II/deal.II/include/fe/mapping_q.h @@ -21,6 +21,8 @@ template class TensorProductPolynomials; +/*!@addtogroup fe */ +/*@{*/ /** * Mapping class that uses Qp-mappings on boundary cells. The mapping @@ -511,6 +513,7 @@ class MappingQ : public MappingQ1 static const bool use_mapping_q_on_all_cells = false; }; +/*@}*/ /* -------------- declaration of explicit specializations ------------- */ diff --git a/deal.II/deal.II/include/fe/mapping_q1.h b/deal.II/deal.II/include/fe/mapping_q1.h index e53e5a4195..4236a12e8c 100644 --- a/deal.II/deal.II/include/fe/mapping_q1.h +++ b/deal.II/deal.II/include/fe/mapping_q1.h @@ -22,6 +22,9 @@ #include +/*!@addtogroup fe */ +/*@{*/ + /** * Mapping of general quadrilateral/hexahedra by d-linear shape * functions. @@ -587,6 +590,8 @@ class MappingQ1 : public Mapping static const unsigned int n_shape_functions = GeometryInfo::vertices_per_cell; }; +/*@}*/ + /*----------------------------------------------------------------------*/ template diff --git a/deal.II/deal.II/include/fe/mapping_q1_eulerian.h b/deal.II/deal.II/include/fe/mapping_q1_eulerian.h index 1057616a41..6f88c5d292 100644 --- a/deal.II/deal.II/include/fe/mapping_q1_eulerian.h +++ b/deal.II/deal.II/include/fe/mapping_q1_eulerian.h @@ -18,6 +18,9 @@ #include +/*!@addtogroup fe */ +/*@{*/ + /** * Eulerian mapping of general unit cells by d-linear shape * functions. Each cell is thus shifted in space by values given to @@ -148,5 +151,6 @@ class MappingQ1Eulerian : public MappingQ1 }; +/*@}*/ #endif diff --git a/deal.II/deal.II/include/grid/tria.h b/deal.II/deal.II/include/grid/tria.h index b79fcee10b..30efffdab1 100644 --- a/deal.II/deal.II/include/grid/tria.h +++ b/deal.II/deal.II/include/grid/tria.h @@ -208,23 +208,53 @@ class TriaDimensionInfo<1> { public: typedef TriaRawIterator<1,CellAccessor<1> > raw_line_iterator; + /** + * Iterator for lines. + */ typedef TriaIterator<1,CellAccessor<1> > line_iterator; + /** + * Iterator for active lines. + */ typedef TriaActiveIterator<1,CellAccessor<1> > active_line_iterator; - + typedef void * raw_quad_iterator; + /** + * Iterator for quads. Void in 1D. + */ typedef void * quad_iterator; + /** + * Iterator for active quads. Void in 1D. + */ typedef void * active_quad_iterator; typedef void * raw_hex_iterator; + /** + * Iterator for hexahedra. Void in 1D. + */ typedef void * hex_iterator; + /** + * Iterator for active hexahedra. Void in 1D. + */ typedef void * active_hex_iterator; typedef raw_line_iterator raw_cell_iterator; + /** + * Iterator for cells. + */ typedef line_iterator cell_iterator; + /** + * Iterator active for cells. + */ typedef active_line_iterator active_cell_iterator; typedef void * raw_face_iterator; + /** + * Iterator for faces. Void in 1D. + */ typedef void * face_iterator; + /** + * Iterator for active faces. Void in 1D. + */ typedef void * active_face_iterator; }; @@ -269,23 +299,53 @@ class TriaDimensionInfo<2> { public: typedef TriaRawIterator<2,TriaObjectAccessor<1, 2> > raw_line_iterator; + /** + * Iterator for lines. + */ typedef TriaIterator<2,TriaObjectAccessor<1, 2> > line_iterator; + /** + * Iterator for active lines. + */ typedef TriaActiveIterator<2,TriaObjectAccessor<1, 2> > active_line_iterator; typedef TriaRawIterator<2,CellAccessor<2> > raw_quad_iterator; + /** + * Iterator for quadrilaterals. + */ typedef TriaIterator<2,CellAccessor<2> > quad_iterator; + /** + * Iterator for active quadrilaterals. + */ typedef TriaActiveIterator<2,CellAccessor<2> > active_quad_iterator; typedef void * raw_hex_iterator; + /** + * Iterator for hexahedra. Void in 2D. + */ typedef void * hex_iterator; + /** + * Iterator for active hexahedra. Void in 2D. + */ typedef void * active_hex_iterator; typedef raw_quad_iterator raw_cell_iterator; + /** + * Iterator for cells. + */ typedef quad_iterator cell_iterator; + /** + * Iterator for active cells. + */ typedef active_quad_iterator active_cell_iterator; typedef raw_line_iterator raw_face_iterator; + /** + * Iterator for faces. + */ typedef line_iterator face_iterator; + /** + * Iterator for active faces. + */ typedef active_line_iterator active_face_iterator; }; @@ -315,23 +375,53 @@ class TriaDimensionInfo<3> { public: typedef TriaRawIterator<3,TriaObjectAccessor<1, 3> > raw_line_iterator; + /** + * Iterator for lines. + */ typedef TriaIterator<3,TriaObjectAccessor<1, 3> > line_iterator; + /** + * Iterator for active lines. + */ typedef TriaActiveIterator<3,TriaObjectAccessor<1, 3> > active_line_iterator; typedef TriaRawIterator<3,TriaObjectAccessor<2, 3> > raw_quad_iterator; + /** + * Iterator for quadrilaterals. + */ typedef TriaIterator<3,TriaObjectAccessor<2, 3> > quad_iterator; + /** + * Iterator for active quadrilaterals. + */ typedef TriaActiveIterator<3,TriaObjectAccessor<2, 3> > active_quad_iterator; typedef TriaRawIterator<3,CellAccessor<3> > raw_hex_iterator; + /** + * Iterator for hexahedra. + */ typedef TriaIterator<3,CellAccessor<3> > hex_iterator; + /** + * Iterator for active hexahedra. + */ typedef TriaActiveIterator<3,CellAccessor<3> > active_hex_iterator; typedef raw_hex_iterator raw_cell_iterator; + /** + * Iterator for cells. + */ typedef hex_iterator cell_iterator; + /** + * Iterator for active cells. + */ typedef active_hex_iterator active_cell_iterator; typedef raw_quad_iterator raw_face_iterator; + /** + * Iterator for faces. + */ typedef quad_iterator face_iterator; + /** + * Iterator for active faces. + */ typedef active_quad_iterator active_face_iterator; }; diff --git a/deal.II/doc/doxygen/headers/deal.II/dox.h b/deal.II/doc/doxygen/headers/deal.II/dox.h index 081662125a..3b2dcbbeed 100644 --- a/deal.II/doc/doxygen/headers/deal.II/dox.h +++ b/deal.II/doc/doxygen/headers/deal.II/dox.h @@ -11,3 +11,24 @@ // //------------------------------------------------------------------------- +/** + * @defgroup grid Grid Handling + */ + +/** + * @defgroup dofs Handling of degrees of freedom + */ + +/** + * @defgroup febase Finite element access classes + */ + +/** + * @defgroup fe Finite element shape functions + */ + +/** + * @defgroup mg Multilevel support + */ + + diff --git a/deal.II/doc/doxygen/headers/lac/dox.h b/deal.II/doc/doxygen/headers/lac/dox.h index 6b24734ba8..5a03c4cf72 100644 --- a/deal.II/doc/doxygen/headers/lac/dox.h +++ b/deal.II/doc/doxygen/headers/lac/dox.h @@ -11,13 +11,6 @@ // //------------------------------------------------------------------------- -/** - * @defgroup LAC The Linear Algebra Classes - * @brief All the classes for linear algebra - * Bla bla bla - * @{ - */ - /** * @defgroup Solvers Linear Solver classes * @@ -33,11 +26,19 @@ /** * @defgroup Matrices Matrix classes * @{ + * + * All matrices in this library have a common minimal interface, + * defined through MATRIX. This interface consists of functions for + * multiplication with appropriate vectors. + * */ /** * @defgroup Matrix1 Basic matrices - */ + * + * These are the actual matrix classes provided by deal.II. They all + * provide some interface for allocating memory and entering values. +*/ /** @@ -48,8 +49,3 @@ * @defgroup Preconditioners Preconditioners * @} */ - - -/** - * @} - */ -- 2.39.5