From eab25a74bebfce08ddc8106fd2817f374bc72d2b Mon Sep 17 00:00:00 2001 From: Ralf Hartmann Date: Mon, 20 Feb 2006 09:30:23 +0000 Subject: [PATCH] Doc update. Bring *Collection functions in a consistent order. git-svn-id: https://svn.dealii.org/trunk@12426 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/fe/fe_collection.h | 38 +++++++------- .../deal.II/include/fe/mapping_collection.h | 48 ++++++++++-------- deal.II/deal.II/include/fe/q_collection.h | 49 ++++++++++--------- 3 files changed, 74 insertions(+), 61 deletions(-) diff --git a/deal.II/deal.II/include/fe/fe_collection.h b/deal.II/deal.II/include/fe/fe_collection.h index 364f6e2f02..10e18bdc79 100644 --- a/deal.II/deal.II/include/fe/fe_collection.h +++ b/deal.II/deal.II/include/fe/fe_collection.h @@ -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 - * add_fe(FE_Q(1));. 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 + * push_back(FE_Q(1));. 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 &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 & 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; diff --git a/deal.II/deal.II/include/fe/mapping_collection.h b/deal.II/deal.II/include/fe/mapping_collection.h index 01951c1f9c..aad3e64755 100644 --- a/deal.II/deal.II/include/fe/mapping_collection.h +++ b/deal.II/deal.II/include/fe/mapping_collection.h @@ -65,23 +65,41 @@ namespace hp MappingCollection (const Mapping &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 &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 & 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 &new_mapping); - private: /** * Upon construction of a diff --git a/deal.II/deal.II/include/fe/q_collection.h b/deal.II/deal.II/include/fe/q_collection.h index a3cc366e3e..ede19a556b 100644 --- a/deal.II/deal.II/include/fe/q_collection.h +++ b/deal.II/deal.II/include/fe/q_collection.h @@ -62,10 +62,30 @@ namespace hp QCollection (const Quadrature &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 + * push_back(QGauss(3));. The + * internal copy is later + * destroyed by this object + * upon destruction of the + * entire collection. */ - unsigned int size () const; + void push_back (const Quadrature &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 - * add_quadrature(QGauss(3));. 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 &new_quadrature); + unsigned int size () const; /** * Determine an estimate for the -- 2.39.5