]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Doc update. Bring *Collection functions in a consistent order.
authorRalf Hartmann <Ralf.Hartmann@dlr.de>
Mon, 20 Feb 2006 09:30:23 +0000 (09:30 +0000)
committerRalf Hartmann <Ralf.Hartmann@dlr.de>
Mon, 20 Feb 2006 09:30:23 +0000 (09:30 +0000)
git-svn-id: https://svn.dealii.org/trunk@12426 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_collection.h
deal.II/deal.II/include/fe/mapping_collection.h
deal.II/deal.II/include/fe/q_collection.h

index 364f6e2f02985f7cb8ccd71a409d118ffe2eddb4..10e18bdc79cfb19b2e1c2426972e1afa01da5b44 100644 (file)
@@ -44,38 +44,40 @@ namespace hp
   {
     public:
                                        /**
-                                        * Add a finite element. This function
-                                        * generates a copy of the given
-                                        * element, i.e. you can do things like
-                                        * <tt>add_fe(FE_Q<dim>(1));</tt>. The
-                                        * internal copy is later destroyed by
-                                        * this object upon destruction of the
+                                        * Add a finite element. This
+                                        * function generates a copy of
+                                        * the given element, i.e. you
+                                        * can do things like
+                                        * <tt>push_back(FE_Q<dim>(1));</tt>. The
+                                        * internal copy is later
+                                        * destroyed by this object
+                                        * upon destruction of the
                                         * entire collection.
                                         *
-                                        * The returned value is the new number
-                                        * of finite elements in the collection.
-                                        *
-                                        * When a new element is added, it needs
-                                        * to have the same number of vector
-                                        * components as all other elements
+                                        * When a new element is added,
+                                        * it needs to have the same
+                                        * number of vector components
+                                        * as all other elements
                                         * already in the collection.
                                         */
       void push_back (const FiniteElement<dim> &new_fe);
 
                                        /**
-                                        * Get a reference to the given element
-                                        * in this collection.
+                                        * Get a reference to the given
+                                        * element in this collection.
                                         *
-                                        * @pre @p index must be between zero
-                                        * and the number of elements of the
+                                        * @pre @p index must be
+                                        * between zero and the number
+                                        * of elements of the
                                         * collection.
                                         */
       const FiniteElement<dim> &
       operator[] (const unsigned int index) const;
 
                                        /**
-                                        * Return the number of finite element
-                                        * objects stored in this collection.
+                                        * Return the number of finite
+                                        * element objects stored in
+                                        * this collection.
                                         */
       unsigned int size () const;
 
index 01951c1f9c9f3f988848dad08c90231cae81d8d1..aad3e64755395112a21dbfafe132642e32d05805 100644 (file)
@@ -65,23 +65,41 @@ namespace hp
       MappingCollection (const Mapping<dim> &mapping);
 
                                        /**
-                                        * Returns the number of mapping
-                                        * objects stored in this container.
+                                        * Adds a new mapping to the
+                                        * MappingCollection.  The
+                                        * mappings have to be added in
+                                        * the order of the
+                                        * active_fe_indices. Thus the
+                                        * reference to the mapping
+                                        * object for active_fe_index 0
+                                        * has to be added first,
+                                        * followed by the mapping
+                                        * object for active_fe_index
+                                        * 1.
                                         */
-      unsigned int size () const;
+      void push_back (const Mapping<dim> &new_mapping);
 
                                        /**
-                                        * Returns the mapping object which
-                                        * was specified by the user for the
-                                        * active_fe_index which is provided
-                                        * as a parameter to this method.
+                                        * Returns the mapping object
+                                        * which was specified by the
+                                        * user for the active_fe_index
+                                        * which is provided as a
+                                        * parameter to this method.
                                         *
-                                        * @pre @p index must be between zero
-                                        * and the number of elements of the
+                                        * @pre @p index must be
+                                        * between zero and the number
+                                        * of elements of the
                                         * collection.
                                         */
       const Mapping<dim> &
       operator[] (const unsigned int index) const;
+
+                                       /**
+                                        * Returns the number of
+                                        * mapping objects stored in
+                                        * this container.
+                                        */
+      unsigned int size () const;
     
                                        /**
                                         * Determine an estimate for the
@@ -90,18 +108,6 @@ namespace hp
                                         */
       unsigned int memory_consumption () const;
 
-                                       /**
-                                        * Adds a new mapping to the
-                                        * MappingCollection.  The mappings
-                                        * have to be added in the order of the
-                                        * active_fe_indices. Thus the
-                                        * reference to the mapping object for
-                                        * active_fe_index 0 has to be added
-                                        * first, followed by the mapping
-                                        * object for active_fe_index 1.
-                                        */
-      void push_back (const Mapping<dim> &new_mapping);
-
     private:
                                        /**
                                         * Upon construction of a
index a3cc366e3efd88024fdc7b9e82c8a74808670f58..ede19a556ba10309ce2eb31409983cc8d26a6b2d 100644 (file)
@@ -62,10 +62,30 @@ namespace hp
       QCollection (const Quadrature<dim> &quadrature);
 
                                        /**
-                                        * Returns the number of quadrature
-                                        * pointers stored in this object.
+                                        * Adds a new quadrature rule
+                                        * to the QCollection.  The
+                                        * quadrature rules have to be
+                                        * added in the same order as
+                                        * for the FECollection for
+                                        * which this quadrature rule
+                                        * collection is meant. Thus
+                                        * the reference to the
+                                        * quadrature rule for
+                                        * active_fe_index 0 has to be
+                                        * added first, followed by the
+                                        * quadrature rule for
+                                        * active_fe_index 1.
+                                        *
+                                        * This class creates a copy of
+                                        * the given quadrature object,
+                                        * i.e. you can do things like
+                                        * <tt>push_back(QGauss<dim>(3));</tt>. The
+                                        * internal copy is later
+                                        * destroyed by this object
+                                        * upon destruction of the
+                                        * entire collection.
                                         */
-      unsigned int size () const;
+      void push_back (const Quadrature<dim> &new_quadrature);
 
                                        /**
                                         * Returns a reference to the
@@ -80,26 +100,11 @@ namespace hp
       operator[] (const unsigned int index) const;
 
                                        /**
-                                        * Adds a new quadrature rule to the
-                                        * QCollection.  The quadrature rules
-                                        * have to be added in the same order
-                                        * as for the FECollection for which
-                                        * this quadrature rule collection is
-                                        * meant. Thus the reference to the
-                                        * quadrature rule for active_fe_index
-                                        * 0 has to be added first, followed by
-                                        * the quadrature rule for
-                                        * active_fe_index 1.
-                                        *
-                                        * This class creates a copy of the
-                                        * given quadrature object, i.e. you
-                                        * can do things like
-                                        * <tt>add_quadrature(QGauss<dim>(3));</tt>. The
-                                        * internal copy is later destroyed by
-                                        * this object upon destruction of the
-                                        * entire collection.
+                                        * Returns the number of
+                                        * quadrature pointers stored
+                                        * in this object.
                                         */
-      void push_back (const Quadrature<dim> &new_quadrature);
+      unsigned int size () const;
     
                                        /**
                                         * Determine an estimate for the

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.