]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
more preparations for doxygen
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 14 Aug 2003 12:42:24 +0000 (12:42 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 14 Aug 2003 12:42:24 +0000 (12:42 +0000)
git-svn-id: https://svn.dealii.org/trunk@7920 0785d39b-7218-0410-832d-ea1e28bc413d

22 files changed:
deal.II/deal.II/include/fe/fe.h
deal.II/deal.II/include/fe/fe_base.h
deal.II/deal.II/include/fe/fe_dgp.h
deal.II/deal.II/include/fe/fe_dgp_nonparametric.h
deal.II/deal.II/include/fe/fe_dgq.h
deal.II/deal.II/include/fe/fe_nedelec.h
deal.II/deal.II/include/fe/fe_q.h
deal.II/deal.II/include/fe/fe_q_hierarchical.h
deal.II/deal.II/include/fe/fe_raviart_thomas.h
deal.II/deal.II/include/fe/fe_system.h
deal.II/deal.II/include/fe/fe_tools.h
deal.II/deal.II/include/fe/fe_update_flags.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/fe/mapping.h
deal.II/deal.II/include/fe/mapping_c1.h
deal.II/deal.II/include/fe/mapping_cartesian.h
deal.II/deal.II/include/fe/mapping_q.h
deal.II/deal.II/include/fe/mapping_q1.h
deal.II/deal.II/include/fe/mapping_q1_eulerian.h
deal.II/deal.II/include/grid/tria.h
deal.II/doc/doxygen/headers/deal.II/dox.h
deal.II/doc/doxygen/headers/lac/dox.h

index 5169361edfe9983bb38df2cfd35e4585fe4bb82a..fcbe0e078b78f90ce319f9f567c6d1519bbbecb0 100644 (file)
@@ -24,6 +24,8 @@ template <int dim> class FEFaceValues;
 template <int dim> class FESubfaceValues;
 template <int dim> class FESystem;
 
+/*!@addtogroup febase */
+/*@{*/
 
 /**
  * Common interface of all finite elements. Here, the functions to
@@ -355,5 +357,6 @@ class FiniteElement : public FiniteElementBase<dim>
     friend class FESystem<dim>;
 };
 
+/*@}*/
 
 #endif
index 85f16c573d76899a83c26a6650d5986466124930..b3561e90b72c18771057f50a7e773263b124d608 100644 (file)
@@ -28,6 +28,8 @@
 
 template<int dim> class FESystem;
 
+/*!@addtogroup febase */
+/*@{*/
 
 
 /**
@@ -1710,7 +1712,7 @@ class FiniteElementBase : public Subscriptor,
                                       */
     friend class InternalDataBase;
 };
-
+/*@}*/
 
 template <int dim>
 inline
index 09c7be61120c72e24f1add26429d1ccfc6f09e57..b783270100dc3d652aa7c97042ab3993e58d0285 100644 (file)
@@ -23,6 +23,9 @@ template <int dim> class PolynomialSpace;
 template <int dim> class MappingQ;
 
 
+/*!@addtogroup fe */
+/*@{*/
+
 /**
  * Discontinuous finite elements based on Legendre polynomials.
  *
@@ -458,13 +461,14 @@ class FE_DGP : public FiniteElement<dim>
     template <int dim1> friend class FE_DGP;
 
                                     /**
-                                     * Allows @p{MappingQ} class to
+                                     * Allows @p{MappingQ} class
                                      * access to build_renumbering
                                      * function.
                                      */
     friend class MappingQ<dim>;
 };
 
+/*@}*/
 
 // declaration of explicit specializations of member variables, if the
 // compiler allows us to do that (the standard says we must)
index 72e594c0f266a54e2983429a020ebb8a00e4282c..479f2b6301feebd5755a0e7ed21f579485dbbda8 100644 (file)
@@ -22,6 +22,9 @@ template <int dim> class PolynomialSpace;
 template <int dim> class MappingQ;
 
 
+/*!@addtogroup fe */
+/*@{*/
+
 /**
  * Discontinuous finite elements evaluated at the mapped quadrature points.
  *
@@ -437,6 +440,7 @@ class FE_DGPNonparametric : public FiniteElement<dim>
     friend class MappingQ<dim>;
 };
 
+/*@}*/
 
 // declaration of explicit specializations of member variables, if the
 // compiler allows us to do that (the standard says we must)
index f5cd910154c284e5f43b2790d3ae601ed6f6e805..bb4af0c9fe5d3bb3438e6fded931042d44a0650c 100644 (file)
@@ -22,6 +22,9 @@ template <int dim> class TensorProductPolynomials;
 template <int dim> class MappingQ;
 
 
+/*!@addtogroup fe */
+/*@{*/
+
 /**
  * Discontinuous tensor product elements based on equidistant support points.
  *
@@ -512,6 +515,7 @@ class FE_DGQ : public FiniteElement<dim>
     template <int dim1> friend class MappingQ;
 };
 
+/*@}*/
 
 // declaration of explicit specializations of member variables, if the
 // compiler allows us to do that (the standard says we must)
index 8cb0977a14f4c360a9e30977cb1c6fa24bf5e050..4798d225abb2b40629588216b110106b8d6ce039 100644 (file)
@@ -20,6 +20,8 @@
 template <int dim> class MappingQ;
 
 
+/*!@addtogroup fe */
+/*@{*/
 
 /**
  * Implementation of continuous Nedelec elements for the space
@@ -608,6 +610,7 @@ class FE_Nedelec : public FiniteElement<dim>
     template <int dim1> friend class FE_Nedelec;
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index 66f3627906a801bd9699aa1e141063d9ac527b10..c771adee7f33bd492c0e9945daf897fc1a35dba5 100644 (file)
@@ -22,6 +22,8 @@ template <int dim> class TensorProductPolynomials;
 template <int dim> class MappingQ;
 
 
+/*!@addtogroup fe */
+/*@{*/
 
 /**
  * Implementation of Lagrange finite elements @p{Qp} that yield the
@@ -843,6 +845,7 @@ class FE_Q : public FiniteElement<dim>
     template <int dim1> friend class FE_Q;
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index 9823c87351641e2b37fafca4f1d74567e801aedb..540fb2a363c00e09d49d6695e26cadd893572029 100644 (file)
@@ -23,6 +23,8 @@ template <int dim> class TensorProductPolynomials;
 template <int dim> class MappingQ;
 
 
+/*!@addtogroup fe */
+/*@{*/
 
 /**
  * Implementation of Hierarchical finite elements @p{Qp} that yield the
@@ -792,6 +794,7 @@ class FE_Q_Hierarchical : public FiniteElement<dim>
     template <int dim1> friend class FE_Q_Hierarchical;
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index 9d88b11fb040d0e8a5c2eb2a9e4f26b617796308..795cdba4257b4843f6b068536b3fbb7093e06027 100644 (file)
@@ -21,6 +21,8 @@
 template <int dim> class MappingQ;
 
 
+/*!@addtogroup fe */
+/*@{*/
 
 /**
  * Implementation of continuous Raviart-Thomas elements for the space
@@ -568,6 +570,7 @@ class FE_RaviartThomas : public FiniteElement<dim>
     template <int dim1> friend class FE_RaviartThomas;
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index 6a9a557ac79fdc2b2feaf96d79e621aa91396ae1..fc642ca8d583529bc5e0686b6bf9d9e6fbc68c76 100644 (file)
@@ -23,6 +23,9 @@
 #include <utility>
 
 
+/*!@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<dim>
     };
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index e204ea7a148fb6e7e14f210e6865ce7579b493f3..fac0190c82c6d812af8940ec722d8e44d829fba0 100644 (file)
@@ -28,6 +28,9 @@ class ConstraintMatrix;
 #include <vector>
 #include <string>
 
+/*!@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 */
index af13de18c4b69615c56b2f6571a16c8fda5ef86a..639e003ab425dae3ac4d5b6fc8f24d4c7eea73f7 100644 (file)
@@ -17,6 +17,9 @@
 #include <base/config.h>
 
 
+/*!@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
index 95d108f51d5d0b78c519258039d5acd2ad34409a..55a104a4b424ea50428037a2b1f29efc2bbc998c 100644 (file)
@@ -33,6 +33,8 @@
 
 template <int dim> class Quadrature;
 
+/*!@addtogroup febase */
+/*@{*/
 
 /**
  * Contains all data vectors for @p{FEValues}.
@@ -1180,7 +1182,7 @@ class FESubfaceValues : public FEFaceValuesBase<dim>
     void initialize (const UpdateFlags update_flags);
 };
 
-
+/*@}*/
 
 /*------------------------ Inline functions: FEValuesBase ------------------------*/
 
index db8e033abf8948d78b6290e3127690a049f0157e..50c2c3e40a440c995b97e90870be3f3b6679d0d2 100644 (file)
@@ -29,6 +29,9 @@ template <int dim> class FEFaceValues;
 template <int dim> class FESubfaceValues;
 
 
+/*!@addtogroup febase */
+/*@{*/
+
 /**
  * Abstract base class for mapping classes.
  *
@@ -524,6 +527,7 @@ class Mapping : public Subscriptor
   friend class FESubfaceValues<dim>;
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index 206eb4c06f923a0efe96bd7280efa5b769b93c7e..35a48508dd8bbbd282ef20a735698bed45ab7c41 100644 (file)
@@ -18,6 +18,9 @@
 #include <fe/mapping_q.h>
 
 
+/*!@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<dim>
                            std::vector<Point<dim> > &a) const;
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index 2161a1e25eaaa461b2faa3520d05cf0f42795f31..f6aef565d8bf36e0d289a657efb5d0e7357a79fd 100644 (file)
@@ -20,6 +20,9 @@
 #include <fe/mapping.h>
 
 
+/*!@addtogroup fe */
+/*@{*/
+
 /**
  * Mapping of an axis-parallel cell.
  *
@@ -261,7 +264,7 @@ class MappingCartesian : public Mapping<dim>
     static const unsigned int invalid_face_number = static_cast<unsigned int>(-1);    
 };
 
-
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index 9071c0cab2b17da844aa9dbf8cfa91fb886d5666..b19964da136815ab1838bb89f4391ec73864ef91 100644 (file)
@@ -21,6 +21,8 @@
 template <int dim> class TensorProductPolynomials;
 
 
+/*!@addtogroup fe */
+/*@{*/
 
 /**
  * Mapping class that uses Qp-mappings on boundary cells. The mapping
@@ -511,6 +513,7 @@ class MappingQ : public MappingQ1<dim>
     static const bool use_mapping_q_on_all_cells = false;
 };
 
+/*@}*/
 
 /* -------------- declaration of explicit specializations ------------- */
 
index e53e5a4195b56e549d1cfd9efbacce853bee5f9c..4236a12e8ca3c98b8a94cb31f8baae87cce4a408 100644 (file)
@@ -22,6 +22,9 @@
 #include <fe/mapping.h>
 
 
+/*!@addtogroup fe */
+/*@{*/
+
 /**
  * Mapping of general quadrilateral/hexahedra by d-linear shape
  * functions.
@@ -587,6 +590,8 @@ class MappingQ1 : public Mapping<dim>
     static const unsigned int n_shape_functions = GeometryInfo<dim>::vertices_per_cell;
 };
 
+/*@}*/
+
 /*----------------------------------------------------------------------*/
 
 template<int dim>
index 1057616a418ed20781f732b920178835db53cc49..6f88c5d292f1de399fba3a098cc5ac4ce0412d59 100644 (file)
@@ -18,6 +18,9 @@
 #include <fe/mapping_q1.h> 
 
 
+/*!@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<dim>
     
 };
 
+/*@}*/
 
 #endif
index b79fcee10b79ce3c9cfb4237a938d54ef261b5e0..30efffdab10fb334a93bdfa9a4dcfb39e5c563d0 100644 (file)
@@ -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;    
 };
 
index 081662125ae19576c417c49eb921a4df1aad8fe8..3b2dcbbeedd3d5fb776065e142b5ae367404f796 100644 (file)
 //
 //-------------------------------------------------------------------------
 
+/**
+ * @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
+ */
+
+
index 6b24734ba89514c55e59cd62af555c37e0d332c3..5a03c4cf72634da4e4f998aeaa7b7341d5a2ab36 100644 (file)
 //
 //-------------------------------------------------------------------------
 
-/**
- * @defgroup LAC The Linear Algebra Classes
- * @brief All the classes for linear algebra
- * Bla bla bla
- * @{
- */
-
 /**
  * @defgroup Solvers Linear Solver classes
  *
 /**
  * @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
  * @}
  */
-
-
-/**
- * @}
- */

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.