From 8cfd4cbb7282736d59e75c8745e98b257e7bc882 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Wed, 18 Jan 2006 01:29:25 +0000 Subject: [PATCH] Further improvements with moving classes into their proper modules git-svn-id: https://svn.dealii.org/trunk@12074 0785d39b-7218-0410-832d-ea1e28bc413d --- .../base/include/base/conditional_ostream.h | 4 +- deal.II/base/include/base/convergence_table.h | 13 +- deal.II/base/include/base/job_identifier.h | 4 +- deal.II/base/include/base/logstream.h | 4 +- deal.II/base/include/base/polynomial.h | 4 +- deal.II/base/include/base/table.h | 283 +++++++++--------- deal.II/base/include/base/table_handler.h | 9 +- deal.II/base/include/base/table_indices.h | 11 +- deal.II/base/include/base/tensor_function.h | 3 +- deal.II/base/include/base/timer.h | 3 +- deal.II/base/include/base/utilities.h | 5 +- deal.II/base/include/base/vector_slice.h | 9 +- deal.II/deal.II/include/dofs/function_map.h | 22 +- .../deal.II/include/grid/grid_refinement.h | 3 +- deal.II/deal.II/include/grid/intergrid_map.h | 3 +- deal.II/deal.II/include/numerics/histogram.h | 5 +- deal.II/doc/doxygen/headers/functions.h | 11 + deal.II/doc/doxygen/headers/grid.h | 3 + deal.II/doc/doxygen/headers/io.h | 34 +-- deal.II/doc/doxygen/headers/memory.h | 2 + deal.II/doc/doxygen/headers/utilities.h | 39 +++ deal.II/lac/include/lac/block_indices.h | 3 +- deal.II/lac/include/lac/eigen.h | 8 +- deal.II/lac/include/lac/solver.h | 3 +- deal.II/lac/include/lac/solver_bicgstab.h | 3 +- deal.II/lac/include/lac/solver_cg.h | 5 +- deal.II/lac/include/lac/solver_control.h | 4 +- deal.II/lac/include/lac/solver_gmres.h | 7 +- deal.II/lac/include/lac/solver_minres.h | 5 +- deal.II/lac/include/lac/solver_qmrs.h | 5 +- deal.II/lac/include/lac/solver_richardson.h | 3 +- deal.II/lac/include/lac/solver_selector.h | 5 +- deal.II/lac/include/lac/vector_memory.h | 5 +- 33 files changed, 300 insertions(+), 230 deletions(-) create mode 100644 deal.II/doc/doxygen/headers/utilities.h diff --git a/deal.II/base/include/base/conditional_ostream.h b/deal.II/base/include/base/conditional_ostream.h index 8ee1b9c7ff..f149a21cb8 100644 --- a/deal.II/base/include/base/conditional_ostream.h +++ b/deal.II/base/include/base/conditional_ostream.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2004, 2005 by the deal.II authors +// Copyright (C) 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -75,7 +75,7 @@ * system_matrix.print_formatted(cout); * @endcode * - * @ingroup output + * @ingroup textoutput * @author Ralf Hartmann, Wolfgang Bangerth, 2004 */ class ConditionalOStream diff --git a/deal.II/base/include/base/convergence_table.h b/deal.II/base/include/base/convergence_table.h index d8a535618a..c28460a675 100644 --- a/deal.II/base/include/base/convergence_table.h +++ b/deal.II/base/include/base/convergence_table.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -33,10 +33,10 @@ * implementations of these non-standard methods is left to a user. * * The number of cells and the number of DoFs may be added to the table by - * calling e.g. add_value("n cells", n_cells). The table - * data is also added by calling add_value(). - * Before the output of the table the functions evaluate_convergence_rates() and - * evaluate_all_convergence_rates() may be called (even multiply). + * calling e.g. add_value("n cells", n_cells). The table data is + * also added by calling add_value(). Before the output of the table the + * functions evaluate_convergence_rates() and evaluate_all_convergence_rates() + * may be called (even multiply). * * There are two possibilities of how to evaluate the convergence rates of multiple * columns in the same RateMode. @@ -48,7 +48,10 @@ * that are not signed to be omitted. * * + * A detailed discussion of this class can also be found in the step-7 and + * step-13 example programs. * + * @ingroup textoutput * @author Ralf Hartmann, 1999 */ class ConvergenceTable: public TableHandler diff --git a/deal.II/base/include/base/job_identifier.h b/deal.II/base/include/base/job_identifier.h index e61957826e..00b8fa89db 100644 --- a/deal.II/base/include/base/job_identifier.h +++ b/deal.II/base/include/base/job_identifier.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -23,6 +23,8 @@ * identifier. There exists a library object dealjobid of this * class. This object can be accessed by all output functions to * provide an id for the current job. + * + * @ingroup utilities */ class JobIdentifier { diff --git a/deal.II/base/include/base/logstream.h b/deal.II/base/include/base/logstream.h index e14a233d76..30262423c3 100644 --- a/deal.II/base/include/base/logstream.h +++ b/deal.II/base/include/base/logstream.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -51,7 +51,7 @@ *
  • deallog.pop() when leaving that stage entered with push. * * - * @ingroup output + * @ingroup textoutput * @author Guido Kanschat, Wolfgang Bangerth, 1999, 2003 */ class LogStream diff --git a/deal.II/base/include/base/polynomial.h b/deal.II/base/include/base/polynomial.h index 736601ef4f..85df4e4c69 100644 --- a/deal.II/base/include/base/polynomial.h +++ b/deal.II/base/include/base/polynomial.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -229,8 +229,6 @@ namespace Polynomials /** - * @brief Monomial of degree n. - * * Class generates Polynomial objects representing a monomial of * degree n, that is, the function $x^n$. * diff --git a/deal.II/base/include/base/table.h b/deal.II/base/include/base/table.h index 6c8255a440..8b000a7f79 100644 --- a/deal.II/base/include/base/table.h +++ b/deal.II/base/include/base/table.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -470,7 +470,8 @@ namespace internal * table is needed here. Furthermore, you may want to store, say, the * gradients of shape functions, so the data type is not a single * scalar value, but a tensor itself. - * + * + * @ingroup data * @author Wolfgang Bangerth, 2002. */ template @@ -736,6 +737,7 @@ class TableBase : public Subscriptor * dimensions. See there, and in the documentation of the base class * for more information. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template @@ -754,6 +756,7 @@ class Table : public TableBase * For the rationale of this class, and a description of the * interface, see the base class. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template @@ -826,6 +829,7 @@ class Table<1,T> : public TableBase<1,T> * compatibility with a predecessor class (vector2d), some * additional functions are provided. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template @@ -976,140 +980,6 @@ class Table<2,T> : public TableBase<2,T> -/** - * A class representing a transpose two-dimensional table, i.e. a matrix of - * objects (not necessarily only numbers) in column first numbering (FORTRAN - * convention). The only real difference is therefore really in the storage - * format. - * - * This class copies the functions of Table<2,T>, but the element - * access and the dimensions will be for the transpose ordering of the - * data field in TableBase. - * - * @author Guido Kanschat, 2005 - */ -template -class TransposeTable : public TableBase<2,T> -{ - public: - /** - * Default constructor. Set all - * dimensions to zero. - */ - TransposeTable (); - - /** - * Constructor. Pass down the - * given dimensions to the base - * class. - */ - TransposeTable (const unsigned int size1, - const unsigned int size2); - - /** - * Reinitialize the object. This - * function is mostly here for - * compatibility with the earlier - * vector2d class. Passes - * down to the base class by - * converting the arguments to - * the data type requested by the - * base class. - */ - void reinit (const unsigned int size1, - const unsigned int size2); - - /** - * Direct access to one element - * of the table by specifying all - * indices at the same time. Range - * checks are performed. - * - * This version of the function - * only allows read access. - */ - const T & operator () (const unsigned int i, - const unsigned int j) const; - - - /** - * Direct access to one element - * of the table by specifying all - * indices at the same time. Range - * checks are performed. - * - * This version of the function - * allows read-write access. - */ - T & operator () (const unsigned int i, - const unsigned int j); - - - /** - * Number of rows. This function - * really makes only sense since - * we have a two-dimensional - * object here. - */ - unsigned int n_rows () const; - - /** - * Number of columns. This function - * really makes only sense since - * we have a two-dimensional - * object here. - */ - unsigned int n_cols () const; - - protected: - /** - * Return a read-write reference - * to the element (i,j). - * - * This function does no bounds - * checking and is only to be - * used internally and in - * functions already checked. - * - * These functions are mainly - * here for compatibility with a - * former implementation of these - * table classes for 2d arrays, - * then called vector2d. - */ - T & el (const unsigned int i, - const unsigned int j); - - /** - * Return the value of the - * element (i,j) as a - * read-only reference. - * - * This function does no bounds - * checking and is only to be - * used internally and in - * functions already checked. - * - * We return the requested value - * as a constant reference rather - * than by value since this - * object may hold data types - * that may be large, and we - * don't know here whether - * copying is expensive or not. - * - * These functions are mainly - * here for compatibility with a - * former implementation of these - * table classes for 2d arrays, - * then called vector2d. - */ - const T & el (const unsigned int i, - const unsigned int j) const; -}; - - - /** * A class representing a three-dimensional table of objects (not * necessarily only numbers). @@ -1117,6 +987,7 @@ class TransposeTable : public TableBase<2,T> * For the rationale of this class, and a description of the * interface, see the base class. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template @@ -1203,6 +1074,7 @@ class Table<3,T> : public TableBase<3,T> * For the rationale of this class, and a description of the * interface, see the base class. * + * @ingroup data * @author Wolfgang Bangerth, Ralf Hartmann 2002 */ template @@ -1292,6 +1164,7 @@ class Table<4,T> : public TableBase<4,T> * For the rationale of this class, and a description of the * interface, see the base class. * + * @ingroup data * @author Wolfgang Bangerth, Ralf Hartmann 2002 */ template @@ -1384,6 +1257,7 @@ class Table<5,T> : public TableBase<5,T> * For the rationale of this class, and a description of the * interface, see the base class. * + * @ingroup data * @author Wolfgang Bangerth, Ralf Hartmann 2002 */ template @@ -1478,6 +1352,7 @@ class Table<6,T> : public TableBase<6,T> * For the rationale of this class, and a description of the * interface, see the base class. * + * @ingroup data * @author Wolfgang Bangerth, 2002, Ralf Hartmann 2004 */ template @@ -1569,6 +1444,142 @@ class Table<7,T> : public TableBase<7,T> +/** + * A class representing a transpose two-dimensional table, i.e. a matrix of + * objects (not necessarily only numbers) in column first numbering (FORTRAN + * convention). The only real difference is therefore really in the storage + * format. + * + * This class copies the functions of Table<2,T>, but the element + * access and the dimensions will be for the transpose ordering of the + * data field in TableBase. + * + * @ingroup data + * @author Guido Kanschat, 2005 + */ +template +class TransposeTable : public TableBase<2,T> +{ + public: + /** + * Default constructor. Set all + * dimensions to zero. + */ + TransposeTable (); + + /** + * Constructor. Pass down the + * given dimensions to the base + * class. + */ + TransposeTable (const unsigned int size1, + const unsigned int size2); + + /** + * Reinitialize the object. This + * function is mostly here for + * compatibility with the earlier + * vector2d class. Passes + * down to the base class by + * converting the arguments to + * the data type requested by the + * base class. + */ + void reinit (const unsigned int size1, + const unsigned int size2); + + /** + * Direct access to one element + * of the table by specifying all + * indices at the same time. Range + * checks are performed. + * + * This version of the function + * only allows read access. + */ + const T & operator () (const unsigned int i, + const unsigned int j) const; + + + /** + * Direct access to one element + * of the table by specifying all + * indices at the same time. Range + * checks are performed. + * + * This version of the function + * allows read-write access. + */ + T & operator () (const unsigned int i, + const unsigned int j); + + + /** + * Number of rows. This function + * really makes only sense since + * we have a two-dimensional + * object here. + */ + unsigned int n_rows () const; + + /** + * Number of columns. This function + * really makes only sense since + * we have a two-dimensional + * object here. + */ + unsigned int n_cols () const; + + protected: + /** + * Return a read-write reference + * to the element (i,j). + * + * This function does no bounds + * checking and is only to be + * used internally and in + * functions already checked. + * + * These functions are mainly + * here for compatibility with a + * former implementation of these + * table classes for 2d arrays, + * then called vector2d. + */ + T & el (const unsigned int i, + const unsigned int j); + + /** + * Return the value of the + * element (i,j) as a + * read-only reference. + * + * This function does no bounds + * checking and is only to be + * used internally and in + * functions already checked. + * + * We return the requested value + * as a constant reference rather + * than by value since this + * object may hold data types + * that may be large, and we + * don't know here whether + * copying is expensive or not. + * + * These functions are mainly + * here for compatibility with a + * former implementation of these + * table classes for 2d arrays, + * then called vector2d. + */ + const T & el (const unsigned int i, + const unsigned int j) const; +}; + + + + /* --------------------- Template and inline functions ---------------- */ #ifndef DOXYGEN diff --git a/deal.II/base/include/base/table_handler.h b/deal.II/base/include/base/table_handler.h index 3f920a4ec8..f73a24c8dd 100644 --- a/deal.II/base/include/base/table_handler.h +++ b/deal.II/base/include/base/table_handler.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -36,6 +36,7 @@ * Abstract base class for the TableEntry class. See there. * This class is not to be used by the user. * + * @ingroup textoutput * @author Ralf Hartmann, 1999 */ class TableEntryBase @@ -72,6 +73,7 @@ class TableEntryBase * * For more detail see the TableHandler class. * + * @ingroup textoutput * @author Ralf Hartmann, 1999 */ template @@ -137,6 +139,10 @@ class TableEntry : public TableEntryBase * to prescribe the format and the captions the columns are written * with in tex mode. * + * A detailed explanation of this class is also given in the step-13 tutorial + * program. + * + * *

    Example

    * * This is a simple example demonstrating the usage of this class. The @@ -170,6 +176,7 @@ class TableEntry : public TableEntryBase * out_file.close(); * @endcode * + * @ingroup textoutput * @author Ralf Hartmann, 1999 */ class TableHandler diff --git a/deal.II/base/include/base/table_indices.h b/deal.II/base/include/base/table_indices.h index 79f65e4929..87d6135d09 100644 --- a/deal.II/base/include/base/table_indices.h +++ b/deal.II/base/include/base/table_indices.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2005 by the deal.II authors +// Copyright (C) 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -25,6 +25,7 @@ * not only stores indices into the TableBase class, but also the sizes of the * table in its various coordinates. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template @@ -77,6 +78,7 @@ class TableIndicesBase * of and access to data is done by the TableIndicesBase base * class of a specializations. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template @@ -108,6 +110,7 @@ class TableIndices * data is done by the TableIndicesBase base class of a * specializations. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template <> @@ -138,6 +141,7 @@ class TableIndices<1> : public TableIndicesBase<1> * specializations. Actual storage of and access to data is done by * the TableIndicesBase base class of a specializations. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template <> @@ -180,6 +184,7 @@ class TableIndices<2> : public TableIndicesBase<2> * specializations. Actual storage of and access to data is done by * the TableIndicesBase base class of a specializations. * + * @ingroup data * @author Wolfgang Bangerth, 2002 */ template <> @@ -222,6 +227,7 @@ class TableIndices<3> : public TableIndicesBase<3> * specializations. Actual storage of and access to data is done by * the TableIndicesBase base class of a specializations. * + * @ingroup data * @author Wolfgang Bangerth, Ralf Hartmann 2002 */ template <> @@ -265,6 +271,7 @@ class TableIndices<4> : public TableIndicesBase<4> * specializations. Actual storage of and access to data is done by * the TableIndicesBase base class of a specializations. * + * @ingroup data * @author Wolfgang Bangerth, Ralf Hartmann 2002 */ template <> @@ -309,6 +316,7 @@ class TableIndices<5> : public TableIndicesBase<5> * specializations. Actual storage of and access to data is done by * the TableIndicesBase base class of a specializations. * + * @ingroup data * @author Wolfgang Bangerth, Ralf Hartmann 2002 */ template <> @@ -354,6 +362,7 @@ class TableIndices<6> : public TableIndicesBase<6> * specializations. Actual storage of and access to data is done by * the TableIndicesBase base class of a specializations. * + * @ingroup data * @author Wolfgang Bangerth, 2002, Ralf Hartmann 2004 */ template <> diff --git a/deal.II/base/include/base/tensor_function.h b/deal.II/base/include/base/tensor_function.h index 08fe825aa4..38643ad180 100644 --- a/deal.II/base/include/base/tensor_function.h +++ b/deal.II/base/include/base/tensor_function.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -48,6 +48,7 @@ * returned, not only vectors, as for them the size can be determined * similarly simply. * + * @ingroup functions * @author Guido Kanschat, 1999 */ template diff --git a/deal.II/base/include/base/timer.h b/deal.II/base/include/base/timer.h index 63ee3f0682..a537df1681 100644 --- a/deal.II/base/include/base/timer.h +++ b/deal.II/base/include/base/timer.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -52,6 +52,7 @@ * right now. In this case, we would like to sum up the time needed by * all children. Furthermore, a wall clock option would be nice. * + * @ingroup utilities * @author G. Kanschat, W. Bangerth */ //TODO:[?] make class work with multithreading as well. better docs. diff --git a/deal.II/base/include/base/utilities.h b/deal.II/base/include/base/utilities.h index 360df88936..aaec1d9c42 100644 --- a/deal.II/base/include/base/utilities.h +++ b/deal.II/base/include/base/utilities.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2005 by the deal.II authors +// Copyright (C) 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -30,6 +30,7 @@ typedef int MPI_Comm; * finite element computing or numerical programs, but nevertheless are needed * in various contexts when writing applications. * + * @ingroup utilities * @author Wolfgang Bangerth, 2005 */ namespace Utilities @@ -137,6 +138,8 @@ namespace Utilities /** * A namespace for utility functions that * probe system properties. + * + * @ingroup utilities */ namespace System { diff --git a/deal.II/base/include/base/vector_slice.h b/deal.II/base/include/base/vector_slice.h index 3f45bc9c63..72c241a820 100644 --- a/deal.II/base/include/base/vector_slice.h +++ b/deal.II/base/include/base/vector_slice.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2004, 2005 by the deal.II authors +// Copyright (C) 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -17,10 +17,10 @@ #include /** - * Filter a range out of any object having a random access operator - * [] (unsigned int) and a function size() const. + * Filter a range out of any object having a random access operator[] + * (unsigned int) and a function size() const. * - * The use of this object is straight forward. It reduplicates the + * The use of this object is straightforward. It reduplicates the * random access operator of the VECTOR and adds an offset to * every index. * @@ -36,6 +36,7 @@ * } * @endcode * + * @ingroup data * @author Guido Kanschat, 2004 */ template diff --git a/deal.II/deal.II/include/dofs/function_map.h b/deal.II/deal.II/include/dofs/function_map.h index 0f42724ff9..c35b51a2e2 100644 --- a/deal.II/deal.II/include/dofs/function_map.h +++ b/deal.II/deal.II/include/dofs/function_map.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -21,16 +21,18 @@ template class Function; /** - * Declare a data type which denotes a mapping between a boundary - * indicator and the function denoting the boundary values on this - * part of the boundary. This type is required in many functions where - * depending on boundary indicators different functions are used, - * e.g. for boundary value interpolation, etc. As a variable of this - * type is often declared in certain contexts where these functions - * are used, this variable is also used by some functions that are not - * actually interested in the function pointer itself, but only in the - * list of selected boundary indicators. + * Declare a data type which denotes a mapping between a boundary indicator + * and the function denoting the boundary values on this part of the + * boundary. This type is required in many functions where depending on the + * boundary indicator, different functions are used. An example is boundary + * value interpolation. * + * It seems odd at first to declare this typedef inside a class, rather than + * declaring a typedef at global scope. The reason is that C++ does not allow + * to define templated typedefs, where here in fact we want a typdef that + * depends on the space dimension. + * + * @ingroup functions * @author Wolfgang Bangerth, Ralf Hartmann, 2001 */ template diff --git a/deal.II/deal.II/include/grid/grid_refinement.h b/deal.II/deal.II/include/grid/grid_refinement.h index 2066dd0f01..de5f6b280f 100644 --- a/deal.II/deal.II/include/grid/grid_refinement.h +++ b/deal.II/deal.II/include/grid/grid_refinement.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -114,6 +114,7 @@ template class Vector; * You can suppress coarsening or refining by giving zero as the fraction * for one of the operations. * + * @ingroup grid * @author Wolfgang Bangerth, 1998, 2000; Thomas Richter, 2000 */ class GridRefinement diff --git a/deal.II/deal.II/include/grid/intergrid_map.h b/deal.II/deal.II/include/grid/intergrid_map.h index 3463b1d2ef..407448841c 100644 --- a/deal.II/deal.II/include/grid/intergrid_map.h +++ b/deal.II/deal.II/include/grid/intergrid_map.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005 by the deal.II authors +// Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -107,6 +107,7 @@ * no dimension is attributed to the first parameter, which here is * DoFHandler (and could equally well be Triangulation or MGDoFHandler). * + * @ingroup grid * @author Wolfgang Bangerth, 1999 */ template