]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
new DOXYGEN conditional and adaption to doxygen 1.4
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 30 Aug 2005 17:41:55 +0000 (17:41 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 30 Aug 2005 17:41:55 +0000 (17:41 +0000)
git-svn-id: https://svn.dealii.org/trunk@11349 0785d39b-7218-0410-832d-ea1e28bc413d

69 files changed:
deal.II/base/include/base/function_parser.h
deal.II/base/include/base/geometry_info.h
deal.II/base/include/base/memory_consumption.h
deal.II/base/include/base/multithread_info.h
deal.II/base/include/base/point.h
deal.II/base/include/base/polynomial_space.h
deal.II/base/include/base/qprojector.h
deal.II/base/include/base/quadrature.h
deal.II/base/include/base/smartpointer.h
deal.II/base/include/base/symmetric_tensor.h
deal.II/base/include/base/table.h
deal.II/base/include/base/tensor.h
deal.II/base/include/base/tensor_base.h
deal.II/base/include/base/tensor_product_polynomials.h
deal.II/base/include/base/thread_management.h
deal.II/base/include/base/utilities.h
deal.II/base/include/base/vector_slice.h
deal.II/deal.II/include/dofs/dof_handler.h
deal.II/deal.II/include/dofs/dof_tools.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_nedelec.h
deal.II/deal.II/include/fe/fe_raviart_thomas.h
deal.II/deal.II/include/fe/fe_values.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/grid/grid_in.h
deal.II/deal.II/include/grid/tria.h
deal.II/deal.II/include/grid/tria_accessor.h
deal.II/deal.II/include/grid/tria_boundary.h
deal.II/deal.II/include/grid/tria_boundary_lib.h
deal.II/deal.II/include/grid/tria_iterator.h
deal.II/deal.II/include/multigrid/mg_block_smoother.h
deal.II/deal.II/include/multigrid/mg_coarse.h
deal.II/deal.II/include/multigrid/mg_smoother.h
deal.II/deal.II/include/multigrid/multigrid.h
deal.II/deal.II/include/numerics/data_out.h
deal.II/deal.II/include/numerics/vectors.h
deal.II/lac/include/lac/block_matrix_array.h
deal.II/lac/include/lac/block_matrix_base.h
deal.II/lac/include/lac/block_vector.h
deal.II/lac/include/lac/block_vector_base.h
deal.II/lac/include/lac/full_matrix.h
deal.II/lac/include/lac/householder.h
deal.II/lac/include/lac/matrix_lib.h
deal.II/lac/include/lac/petsc_matrix_base.h
deal.II/lac/include/lac/petsc_parallel_vector.h
deal.II/lac/include/lac/petsc_vector.h
deal.II/lac/include/lac/petsc_vector_base.h
deal.II/lac/include/lac/precondition.h
deal.II/lac/include/lac/precondition_block.h
deal.II/lac/include/lac/solver_bicgstab.h
deal.II/lac/include/lac/solver_cg.h
deal.II/lac/include/lac/solver_control.h
deal.II/lac/include/lac/solver_minres.h
deal.II/lac/include/lac/solver_qmrs.h
deal.II/lac/include/lac/solver_richardson.h
deal.II/lac/include/lac/sparse_decomposition.h
deal.II/lac/include/lac/sparse_ilu.h
deal.II/lac/include/lac/sparse_matrix.h
deal.II/lac/include/lac/sparse_matrix_ez.h
deal.II/lac/include/lac/sparse_vanka.h
deal.II/lac/include/lac/sparsity_pattern.h
deal.II/lac/include/lac/swappable_vector.h
deal.II/lac/include/lac/tridiagonal_matrix.h
deal.II/lac/include/lac/vector.h
deal.II/lac/include/lac/vector_memory.h

index d96b0da5355eeb1b88c617397ce50e1992fb564d..9e9ed55b1953d0ea51d41feb6e0fa86dce41cb22 100644 (file)
@@ -308,7 +308,7 @@ class FunctionParser : public Function<dim>
                                       * second component and so forth. If this
                                       * function is also time dependent, then
                                       * it is necessary to specify it by
-                                      * setting the #time_dependent parameter
+                                      * setting the <tt>time_dependent</tt> parameter
                                       * to true.  An exception is thrown if
                                       * the number of variables specified here
                                       * is different from dim (if this
index a9aed587f76a54e56cb88e2a1b1fe527641f2a94..606fa6c2b5c33be9088abf201b5a70c034775394 100644 (file)
@@ -32,7 +32,7 @@ template <int dim> class GeometryInfo;
  * This class contains as static members information on vertices and
  * faces of a @p dim-dimensional grid cell. The interface is the same
  * for all dimensions. If a value is of no use in a low dimensional
- * cell, it is (correctly) set to zero, e.g. #subfaces_per_cell in
+ * cell, it is (correctly) set to zero, e.g. #subfaces_per_face in
  * 1d.
  *
  * This information should always replace hard-coded numbers of
@@ -113,7 +113,7 @@ struct GeometryInfo<0>
  * of the mesh cells.
  *
  * @ingroup grid
- * @ref Instantiations: few (dim = 1,2,3,4 and a specialization for dim=0)
+ * @ref Instantiations few (dim = 1,2,3,4 and a specialization for dim=0)
  * @author Wolfgang Bangerth, 1998, Ralf Hartmann, 2005
  */
 template <int dim>
@@ -474,7 +474,7 @@ struct GeometryInfo
 /* -------------- declaration of explicit specializations ------------- */
 
 
-
+#ifndef DOXYGEN
 
 template <>
 inline
@@ -652,6 +652,6 @@ GeometryInfo<3>::is_inside_unit_cell (const Point<3> &p)
         (p[2] >= 0.) && (p[2] <= 1.);
 }
 
-
+#endif // DOXYGEN
 
 #endif
index 613b3f5e45d8b41d9ae68289c9943e52f52aadfa..d9f8da7af930b8257a81d5d36ab713e1e2099db0 100644 (file)
@@ -387,8 +387,6 @@ namespace MemoryConsumption
 
 // now comes the implementation of these functions
 
-/// @if NoDoc
-
 namespace MemoryConsumption
 {
   inline
@@ -598,6 +596,5 @@ namespace MemoryConsumption
   }
 }
 
-/// @endif
 
 #endif
index f0e762bd7190f8f0b3771d977a3c0342be5cff19..c606af25396169038aa55751da5d5fe616ad3d1b 100644 (file)
@@ -59,7 +59,7 @@ class MultithreadInfo
                                      * machine, please refer to the
                                      * documentation in
                                      * <tt>multithread_info.cc</tt>
-                                     * near to the #error directive.
+                                     * near to the <tt>error</tt> directive.
                                      */
     const unsigned int n_cpus;
 
index fda71c498a746cc045adac046ac80618bbc7d003..83fdaa2c162d042473cbb0b60d6e6f3c093ec523 100644 (file)
@@ -195,6 +195,7 @@ class Point : public Tensor<1,dim>
 
 /*------------------------------- Inline functions: Point ---------------------------*/
 
+#ifndef DOXYGEN
 
 template <int dim>
 inline
@@ -355,6 +356,7 @@ Point<dim> Point<dim>::operator / (const double factor) const
   return (Point<dim>(*this) /= factor);
 }
 
+#endif // DOXYGEN
 
 
 /*------------------------------- Global functions: Point ---------------------------*/
@@ -362,6 +364,7 @@ Point<dim> Point<dim>::operator / (const double factor) const
 
 /**
  * Global operator scaling a point vector by a scalar.
+ * @relates Point
  */
 template <int dim>
 inline
@@ -374,6 +377,7 @@ Point<dim> operator * (const double factor, const Point<dim> &p)
 /**
  * Output operator for points. Print the elements consecutively,
  * with a space in between.
+ * @relates Point
  */
 template <int dim>
 inline
@@ -392,6 +396,7 @@ std::ostream & operator << (std::ostream     &out,
 /**
  * Output operator for points. Print the elements consecutively,
  * with a space in between.
+ * @relates Point
  */
 template <int dim>
 inline
@@ -405,6 +410,7 @@ std::istream & operator >> (std::istream &in,
 }
 
 
+#ifndef DOXYGEN
 
 /** 
  * Output operator for points of dimension 1. This is implemented
@@ -419,4 +425,6 @@ std::ostream & operator << (std::ostream &out, const Point<1> &p)
   return out;
 }
 
+#endif // DOXYGEN
+
 #endif
index 08a7a43bf9b3a52f1e53ddfdffd5ec6d861f3896..af46c6d734c560b04752cacc0b7b86bd30acdf2a 100644 (file)
@@ -251,7 +251,6 @@ class PolynomialSpace
     std::vector<unsigned int> index_map_inverse;
 };
 
-/// @if NoDoc
 
 /* -------------- declaration of explicit specializations --- */
 
@@ -327,6 +326,4 @@ PolynomialSpace<dim>::output_indices(STREAM &out) const
 
 
 
-/// @endif  
-
 #endif
index 65c269dcc20a7a61412ca7e767333f7604767c56..a4232e56c1c748d79f3938c1548167cbc69214e1 100644 (file)
@@ -381,10 +381,11 @@ class QProjector
 
 /*@}*/
 
-/// @if NoDoc
 
 /* -------------- declaration of explicit specializations ------------- */
 
+#ifndef DOXYGEN
+
 template <>
 void
 QProjector<1>::project_to_face (const Quadrature<0> &,
@@ -439,6 +440,6 @@ QIterated<1>::QIterated (const Quadrature<1> &base_quadrature,
                         const unsigned int   n_copies);
 
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index af45cce0facb174225a7320c5004acb42423b6a9..7d4273ff3a8603788e2236cb9835e7104cb7be29 100644 (file)
@@ -73,7 +73,7 @@
  * necessary to provide a class Point@<0@> to make the compiler
  * happy. This class also does nothing.
  *
- * @ref Instantiations: few
+ * @ref Instantiations few
  *
  * @author Wolfgang Bangerth, Guido Kanschat, 1998, 1999, 2000, 2005
  */
@@ -320,7 +320,7 @@ class QIterated : public Quadrature<dim>
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 /* -------------- declaration of explicit specializations ------------- */
 
@@ -343,6 +343,6 @@ double Quadrature<0>::weight (const unsigned int) const;
 template <>
 const std::vector<double> & Quadrature<0>::get_weights () const;
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index ee877835d101215d7d47fcfbc823e4d2496751e5..b0b545b5598c355b0c5bc019b5e1e6a06479f4e4 100644 (file)
@@ -58,7 +58,7 @@ class SmartPointer
                                      * Standard constructor for null
                                      * pointer.  @deprecated Since
                                      * this constructor will leave
-                                     * #id empty, it should be
+                                     * SmartPointer::id empty, it should be
                                      * avoided wherever possible and
                                      * replaced by SmartPointer(0,id).
                                      */
index 138ee6a2e4f7fbe25b188ff67e5c1706b66f4c26..b61da79d5598855c413dcc39a9d3ba0bc068a2bf 100644 (file)
@@ -915,7 +915,7 @@ class SymmetricTensor
 
 // ------------------------- inline functions ------------------------
 
-///@if NoDoc
+#ifndef DOXYGEN
 
 namespace internal
 {
@@ -1881,7 +1881,7 @@ SymmetricTensor<4,3>::norm () const
   return std::sqrt(t);
 }
 
-///@endif
+#endif // DOXYGEN
 
 /* ----------------- Non-member functions operating on tensors. ------------ */
 
index 41b68089f12dd72eee29287abef6822576fefafe..141ee3634ac8bb4644c1e42fc8bc2f52bf439d39 100644 (file)
@@ -1563,9 +1563,10 @@ class Table<7,T> : public TableBase<7,T>
 };
 
 
-///@if NoDoc
+
 /* --------------------- Template and inline functions ---------------- */
 
+#ifndef DOXYGEN
 
 template <int N, typename T>
 TableBase<N,T>::TableBase ()
@@ -2851,6 +2852,6 @@ Table<7,T>::operator () (const unsigned int i,
                   *this->table_size[6] + o];
 }
 
-///@endif
+#endif // DOXYGEN
 
 #endif
index a8df8cc73027ecd29d3eb677acf8afe451cb4212..73dd8bba2a1f028d7bf6639e0f7068d3aceb6bd3 100644 (file)
@@ -255,7 +255,7 @@ class Tensor
 
 /*--------------------------- Inline functions -----------------------------*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <int rank_, int dim>
 inline
@@ -456,7 +456,7 @@ Tensor<rank_,dim>::memory_consumption ()
   return sizeof(Tensor<rank_,dim>);
 }
 
-/// @endif
+#endif // DOXYGEN
 /* ----------------- Non-member functions operating on tensors. ------------ */
 
 
@@ -477,6 +477,7 @@ std::ostream & operator << (std::ostream &out, const Tensor<rank_,dim> &p)
   return out;
 }
 
+#ifndef DOXYGEN
 
 /**
  * Specialization for 1D.
@@ -490,6 +491,7 @@ std::ostream & operator << (std::ostream &out, const Tensor<rank_,1> &p)
   return out;
 }
 
+#endif // DOXYGEN
 
 
 /**
@@ -1352,7 +1354,7 @@ transpose (const Tensor<2,dim> &t)
   return tt;
 }
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 /**
  * Return the transpose of the given tensor. This is the
@@ -1406,7 +1408,7 @@ transpose (const Tensor<2,3> &t)
   return Tensor<2,3>(x);
 }
 
-/// @endif
+#endif // DOXYGEN
 
 
 /**
index 566e55a2972ea1184f354b53a0be814d095dec5d..d35e4b9977480c1167e49a5f9895efdbc494ce40 100644 (file)
@@ -359,7 +359,7 @@ class Tensor<1,dim>
 template <int dim>
 std::ostream & operator << (std::ostream &out, const Tensor<1,dim> &p);
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 /*------------------------------- Inline functions: Tensor ---------------------------*/
 
@@ -788,7 +788,7 @@ operator / (const Tensor<1,dim> &t,
   return tt;
 }
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
 
index d079f930c87d8aecc4c3a950f477505780292cdc..55bc88a685ddf26cba03922509021c7e2ac32b53 100644 (file)
@@ -262,7 +262,7 @@ class TensorProductPolynomials
     unsigned int x_to_the_dim (const unsigned int x);
 };
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <int dim>
 inline
@@ -282,7 +282,7 @@ TensorProductPolynomials<dim>::get_numbering_inverse() const
 }
 
 
-/// @endif
+#endif // DOXYGEN
 
 
 /**
@@ -485,7 +485,7 @@ class AnisotropicPolynomials
 };
 
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 /* -------------- declaration of explicit specializations --- */
 
@@ -555,6 +555,6 @@ void
 AnisotropicPolynomials<3>::compute_index(const unsigned int n,
                                          unsigned int      (&index)[3]) const;
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 0b03caa979ea164fe9a6f224b1123a049bc77792..6aad91550cacd8604897df8de533e843824de4d9 100644 (file)
@@ -758,7 +758,7 @@ namespace Threads
 }   // end declarations of namespace Threads
 
 /* ----------- implementation of functions in namespace Threads ---------- */
-/// @if NoDoc
+#ifndef DOXYGEN
 namespace Threads 
 {  
   template <typename ForwardIterator>
@@ -820,7 +820,7 @@ namespace Threads
   }  
 }
 
-///@endif
+#endif // DOXYGEN
 
 namespace Threads
 {
index 713190d4a3ab17f2b520c775495cd45df7219053..a3f66a3ac2e88deeaf7b625e669369524dd416f5 100644 (file)
@@ -31,7 +31,7 @@ namespace Utilities
 {
 
                                    /**
-                                    * Convert a number #i to a string, with
+                                    * Convert a number @p i to a string, with
                                     * as many digits as given to fill with
                                     * leading zeros.
                                     */
@@ -66,7 +66,7 @@ namespace Utilities
 
                                    /**
                                     * Given a string that contains text
-                                    * separated by a #delimiter, split it into
+                                    * separated by a @p delimiter, split it into
                                     * its components; for each component,
                                     * remove leading and trailing spaces.
                                     *
@@ -81,8 +81,8 @@ namespace Utilities
                                    /**
                                     * Generate a random number from a
                                     * normalized Gaussian probability
-                                    * distribution centered around #a and
-                                    * with standard deviation #sigma.
+                                    * distribution centered around @p a and
+                                    * with standard deviation @p sigma.
                                     */
   double
   generate_normal_random_number (const double a,
index f16d894b8b276e239abfe52a447d438f8c127e1b..3f45bc9c632655b8ddf2b7f3e75232b4191c3db8 100644 (file)
@@ -76,7 +76,7 @@ class VectorSlice
                                      * using the same interface as
                                      * <tt>std::vector</tt>.
                                      */
-    typename VECTOR::reference operator[] (unsigned int);
+    typename VECTOR::reference operator[] (unsigned int i);
     
                                     /**
                                      * Access an element of a
@@ -84,7 +84,7 @@ class VectorSlice
                                      * interface as
                                      * <tt>std::vector</tt>.
                                      */
-    typename VECTOR::const_reference operator[] (unsigned int) const;
+    typename VECTOR::const_reference operator[] (unsigned int i) const;
   private:
                                     /**
                                      * The vector we extract from.
index 0aed877576b1b0bb62a76e8fca688f4db7e1118d..a2fe4b218762b8aa9d320e49bd7a9f2445f69afe 100644 (file)
@@ -39,11 +39,11 @@ template <int dim> class Triangulation;
 
 
 /**
- * Define some types which differ between the dimensions. This class
- * is analogous to the TriaDimensionInfo class hierarchy.
+ * Define some types which differ between the dimensions.
  * 
  * @ref DoFDimensionInfo<1>
  * @ref DoFDimensionInfo<2>
+ * @ref DoFDimensionInfo<3>
  *
  * @ingroup dofs
  * @author Wolfgang Bangerth, 1998
@@ -157,8 +157,6 @@ class DoFDimensionInfo
 /**
  * Define some types for the DoF handling in one dimension.
  *
- * The types have the same meaning as those declared in TriaDimensionInfo<2>.
- *
  * @ingroup dofs
  * @author Wolfgang Bangerth, 1998
  */
@@ -192,8 +190,6 @@ class DoFDimensionInfo<1>
 /**
  * Define some types for the DoF handling in two dimensions.
  *
- * The types have the same meaning as those declared in TriaDimensionInfo<2>.
- *
  * @ingroup dofs
  * @author Wolfgang Bangerth, 1998
  */
@@ -227,8 +223,6 @@ class DoFDimensionInfo<2>
 /**
  * Define some types for the DoF handling in two dimensions.
  *
- * The types have the same meaning as those declared in TriaDimensionInfo<3>.
- *
  * @ingroup dofs
  * @author Wolfgang Bangerth, 1998
  */
index 0e5245033c9fd2bfe706b96296dbb70530f4cab8..eefc4f7c239fe3d21202125c8870f584d648eb14 100644 (file)
@@ -115,11 +115,11 @@ template <int dim> class Mapping;
  * indices of degrees of freedom on different parts may be intermixed.
  *
  * Degrees of freedom on the boundary but not on one of the specified
- * boundary parts are given the index #invalid_dof_index, as if
+ * boundary parts are given the index DoFHandler::invalid_dof_index, as if
  * they were in the interior. If no boundary indicator was given or if
  * no face of a cell has a boundary indicator contained in the given
  * list, the vector of new indices consists solely of
- * #invalid_dof_index.
+ * DoFHandler::invalid_dof_index.
  *
  * The question what a degree of freedom on the boundary is, is not so
  * easy.  It should really be a degree of freedom of which the
@@ -426,7 +426,7 @@ class DoFTools
                                      * @deprecated This is the old
                                      * form of the previous
                                      * function. It generates a table
-                                     * of #Coupling values and calls
+                                     * of DoFTools::Coupling values and calls
                                      * it.
                                      */
     template <int dim, class SparsityPattern>
index 8952194add58ec1ccc617b1f417d4035538ad19e..3a8df6724a77bc66e3eacfd08b3285f61810e93d 100644 (file)
@@ -155,7 +155,7 @@ class FE_DGP : public FE_Poly<PolynomialSpace<dim>,dim>
 };
 
 /* @} */
-/// @if NoDoc
+#ifndef DOXYGEN
 
 
 // declaration of explicit specializations of member variables, if the
@@ -180,5 +180,5 @@ template <>
 const unsigned int FE_DGP<3>::Matrices::n_projection_matrices;
 #endif
 
-/// @endif
+#endif // DOXYGEN
 #endif
index 0b7fab840051b4cc6dfd710b8912bc11ddbc7c85..f2a489a86c52e48184befcbca2a7ba9ad98fc579 100644 (file)
@@ -442,7 +442,7 @@ class FE_DGPNonparametric : public FiniteElement<dim>
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 // declaration of explicit specializations of member variables, if the
 // compiler allows us to do that (the standard says we must)
@@ -484,6 +484,6 @@ template <>
 const unsigned int FE_DGPNonparametric<3>::Matrices::n_projection_matrices;
 #endif
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index c316a6e8c880d82714826c2291dd517d709ab7ef..e43b19c94bbd6971048beb054a12f5c8ed8fd62d 100644 (file)
@@ -607,7 +607,7 @@ class FE_Nedelec : public FiniteElement<dim>
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 
 /* -------------- declaration of explicit specializations ------------- */
@@ -714,5 +714,5 @@ template <>
 const unsigned int FE_Nedelec<3>::Matrices::n_constraint_matrices;
 
 #endif
-/// @endif
+#endif // DOXYGEN
 #endif
index f8f3905150d2c30122df921a7f26c0259f854384..d01d299ac0d24c92722610037d83be84e7698749 100644 (file)
@@ -676,7 +676,7 @@ class FE_RaviartThomasNodal
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <>
 void FE_RaviartThomas<1>::initialize_unit_face_support_points ();
@@ -742,6 +742,6 @@ FE_RaviartThomas<1>::
 get_interpolation_matrix (const FiniteElement<1> &,
                          FullMatrix<double>         &) const;
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index b32aeaf8ad4d00d0a505b1ca7853800cee56d3a6..873314ac17a4ccad283b34644414ab82e4e6f7c7 100644 (file)
@@ -2202,7 +2202,7 @@ class FESubfaceValues : public FEFaceValuesBase<dim>
 
 /*@}*/
 
-///@if NoDoc
+#ifndef DOXYGEN
 /*------------------------ Inline functions: FEValuesBase ------------------------*/
 
 
@@ -2651,7 +2651,7 @@ FEFaceValuesBase<dim>::boundary_form (const unsigned int i) const
   return this->boundary_forms[i];
 }
 
-///@endif
+#endif // DOXYGEN
 
 
 #endif
index 2cff467726ba5d6cdae83ef24445ce319f15d3a4..d7405a65c37f041100a0263b926fa0dda84462d8 100644 (file)
@@ -108,7 +108,7 @@ class MappingC1 : public MappingQ<dim>
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <> void MappingC1<1>::add_line_support_points (
   const Triangulation<1>::cell_iterator &,
@@ -125,6 +125,6 @@ template <> void MappingC1<2>::add_quad_support_points (
   std::vector<Point<2> > &) const;
 
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 3db7e6fddae5f30c848f8aca9a1a5fa6f3e0d3cb..716ca732a80d05c7cdba2c702091cbec84e308bf 100644 (file)
@@ -213,7 +213,7 @@ class MappingCartesian : public Mapping<dim>
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <> void MappingCartesian<1>::fill_fe_face_values (
   const Triangulation<1>::cell_iterator &,
@@ -236,6 +236,6 @@ template <> void MappingCartesian<1>::fill_fe_subface_values (
   std::vector<Tensor<1,1> >&,
   std::vector<Point<1> >&) const;
 
-/// @endif  
+#endif // DOXYGEN  
 
 #endif
index 328b63394137edc28b1f711ee36fe3f5cc4e35d0..8de37b52b193fe114b87a6366b23d05e98f178ad 100644 (file)
@@ -518,7 +518,7 @@ class MappingQ : public MappingQ1<dim>
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template<> MappingQ<1>::MappingQ (const unsigned int);
 template<> MappingQ<1>::~MappingQ ();
@@ -538,6 +538,6 @@ template<> void MappingQ<3>::add_quad_support_points(
   const Triangulation<3>::cell_iterator &cell,
   std::vector<Point<3> >                &a) const;
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 525411f8e34fa7f77789291ebf532bf5e4637e2d..286a826e7b9f5c36c115694514db3e257c47f23c 100644 (file)
@@ -667,7 +667,7 @@ MappingQ1<dim>::InternalData::derivative (const unsigned int qpoint,
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 // declaration of explicit specializations of member variables, if the
 // compiler allows us to do that (the standard says we must)
@@ -727,6 +727,6 @@ template <> void MappingQ1<1>::fill_fe_subface_values (
   std::vector<Tensor<1,1> >&,
   std::vector<Point<1> >&) const;
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 87adb544a2effd03be3e9b0a83a2f7ab0fc3bb75..0c9330f76742695bd4603511a0e04bbed91402f0 100644 (file)
@@ -435,7 +435,7 @@ class GridIn
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <>
 void
@@ -448,6 +448,6 @@ GridIn<3>::debug_output_grid (const std::vector<CellData<3> > &cells,
                              const std::vector<Point<3> >    &vertices,
                              std::ostream                    &out);
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 6faee8b0fb6c5f37dc14ae6abaefe413e8023d4b..881d7239d2faf96a8ec8eeb15a902c6bb4491e93 100644 (file)
@@ -33,6 +33,7 @@ template <int dim> class MGDoFHandler;
 
 /*------------------------------------------------------------------------*/
 
+//TODO:[WB] remove reference to non-existing TriaDimensionInfo
 
 /**
  *  Structure which is passed to the
@@ -3364,7 +3365,7 @@ class Triangulation : public Subscriptor
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <> Triangulation<1>::cell_iterator Triangulation<1>::begin (const unsigned int level) const;
 template <> Triangulation<1>::raw_cell_iterator Triangulation<1>::end () const;
@@ -3507,6 +3508,6 @@ template <> void Triangulation<1>::update_number_cache_quads ();
 template <> void Triangulation<1>::update_number_cache_hexes ();
 template <> void Triangulation<2>::update_number_cache_hexes ();
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 8020796c759c7b4acb56aa84d74050ed303369f4..5fb17917d773e56198a677f7a612e23c3c29d9b3 100644 (file)
@@ -2723,7 +2723,7 @@ class CellAccessor :  public TriaObjectAccessor<dim,dim>
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <> Point<2> TriaObjectAccessor<2, 2>::barycenter () const;
 template <> Point<3> TriaObjectAccessor<2, 3>::barycenter () const;
@@ -2768,6 +2768,6 @@ template <> double TriaObjectAccessor<3, 3>::measure () const;
 // include more templates in debug and optimized mode
 #  include "tria_accessor.templates.h"
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index c9b5dbdf469eeb4f03a55b10ba88bb67822015f6..2f4365f2a896af0a34f1e4ef9baa7f9042b0dc34 100644 (file)
@@ -358,7 +358,7 @@ class StraightBoundary : public Boundary<dim>
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <>
 void
@@ -393,6 +393,6 @@ StraightBoundary<3>::
 get_intermediate_points_on_quad (const Triangulation<3>::quad_iterator &quad,
                                 std::vector<Point<3> > &points) const;
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 638804b62ff527cfdd58bf4e112121d2c397faeb..c4e415d603a7b218d5f611789bf5bd36d0d51f8c 100644 (file)
@@ -496,7 +496,7 @@ class HalfHyperShellBoundary : public HyperShellBoundary<dim>
 
 /* -------------- declaration of explicit specializations ------------- */
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 template <>
 Point<1>
@@ -546,6 +546,6 @@ HalfHyperShellBoundary<1>::
 get_normals_at_vertices (const Triangulation<1>::face_iterator &,
                         Boundary<1>::FaceVertexNormals &) const;
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 9707388df16610b32ea9ebaa07cf5871840c25d5..35cc0849f59d5975ccfab1622e8c964d1dc1a746 100644 (file)
@@ -205,7 +205,7 @@ template <int dim> class Triangulation;
  * and the state of the element pointed to.
  *
  * Past-the-end iterators may also be used to compare an iterator with the
- * @em{before-the-start} value, when running backwards. There is no
+ * <i>before-the-start</i> value, when running backwards. There is no
  * distiction between the iterators pointing past the two ends of a vector.
  *   
  * By defining only one value to be past-the-end and making all other values
@@ -216,9 +216,6 @@ template <int dim> class Triangulation;
  * earlier than for past-the-end iterators an exception is raised.
  *
  * @ref Triangulation
- * @ref TriaDimensionInfo<1>
- * @ref TriaDimensionInfo<2>
- * @ref TriaDimensionInfo<3>
  * @ingroup grid
  * @ingroup Iterators
  * @author Wolfgang Bangerth, 1998
index f01549256bc0c324df31424321df62fc20a7c3e6..c6f8dda9d092ff92bba5aac7b09eb57ee6d09227 100644 (file)
@@ -179,6 +179,8 @@ class MGSmootherBlock
 
 //---------------------------------------------------------------------------
 
+#ifndef DOXYGEN
+
 template <class MATRIX, class RELAX, typename number>
 inline
 MGSmootherBlock<MATRIX, RELAX, number>::MGSmootherBlock(
@@ -328,6 +330,6 @@ MGSmootherBlock<MATRIX, RELAX, number>::smooth(
   deallog.pop();
 }
 
-
+#endif // DOXYGEN
 
 #endif
index d64e241eb4670b110088092fa249212d256dd3ed..3ea09baf49b1ade58a5ccc5bf758c24d1a6f4a7b 100644 (file)
@@ -173,7 +173,7 @@ class MGCoarseGridHouseholder : public MGCoarseGridBase<VECTOR>
 
 /*@}*/
   
-/// @if NoDoc
+#ifndef DOXYGEN
 /* ------------------ Functions for MGCoarseGridLACIteration ------------ */
 
 
@@ -309,6 +309,6 @@ MGCoarseGridHouseholder<number, VECTOR>::operator() (
   work.least_squares(dst, aux);
 }
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index cbc91195a6e6a731df447a6d2a1350a3a675a39d..c1c4f112e525590b3653ca141eeb0b135d3450a4 100644 (file)
@@ -373,6 +373,8 @@ class MGSmootherRelaxation : public MGSmootherBase<VECTOR>
 
 /* ------------------------------- Inline functions -------------------------- */
 
+#ifndef DOXYGEN
+
 template <class VECTOR>
 inline void
 MGSmootherIdentity<VECTOR>::smooth (
@@ -582,5 +584,6 @@ memory_consumption () const
 }
 
 
+#endif // DOXYGEN
 
 #endif
index a28eb4b1363d77c4bca3e8869a59b8117cbbb85b..ed612cd6e08ecd449b844683dea936ffef2c5882 100644 (file)
@@ -507,7 +507,7 @@ class PreconditionMG : public Subscriptor
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 /* --------------------------- inline functions --------------------- */
 
 
@@ -635,6 +635,6 @@ PreconditionMG<dim, VECTOR, TRANSFER>::Tvmult_add (
   Assert(false, ExcNotImplemented());
 }
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index 3c4471d8a9805155c81e9315d12cbadc669f6f81..5513190b67592385802c7148042a49f00ad9ab20 100644 (file)
@@ -934,7 +934,7 @@ class DataOut : public DataOut_DoFData<dim,dim>
                                      * globally to avoid allocation
                                      * of memory in the threads.
                                      *
-                                     * The #index_to_patch_map is
+                                     * The #cell_to_patch_index_map is
                                      * an array that stores for index
                                      * <tt>[i][j]</tt> the number of the
                                      * patch that associated with the
index 2b37acf61a209d68be23a49cfaea08bbdf7bb707..73cd10f16465a60227389b437eaade73fd7a37bb 100644 (file)
@@ -292,7 +292,7 @@ class ConstraintMatrix;
  * if access to an object describing the exact form of the boundary is needed, the
  * pointer stored within the triangulation object is accessed.
  *
- * @ref Instantiations: some (Vector<float>, Vector<double>, BlockVector<float>, BlockVector<double>, see also individual functions)
+ * @ref Instantiations : some (Vector<float>, Vector<double>, BlockVector<float>, BlockVector<double>, see also individual functions)
  * @author Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, 1998, 1999, 2000, 2001
  */
 class VectorTools
@@ -434,7 +434,7 @@ class VectorTools
                                      * make the result continuous
                                      * again.
                                      *
-                                     * @ref Instantiations: some (the
+                                     * @ref Instantiations : some (the
                                      * standard vector types
                                      * mentioned in the class
                                      * documentation are
@@ -452,7 +452,7 @@ class VectorTools
 
                                     /**
                                      * Compute the projection of
-                                     * @function to the finite element space.
+                                     * @function to the finite element space.
                                      *
                                      * By default, projection to the boundary
                                      * and enforcement of zero boundary values
@@ -467,18 +467,16 @@ class VectorTools
                                      * matrix of the finite element
                                      * space on the present grid. To
                                      * this end, the mass matrix is
-                                     * assembled exactly using the
-                                     * @p create_mass_matrix
-                                     * function in the
-                                     * MatrixTools
-                                     * collection. This function
-                                     * performs numerical quadrature
-                                     * using the given quadrature
-                                     * rule; you should therefore
-                                     * make sure that the given
-                                     * quadrature formula is also
-                                     * sufficient for the integration
-                                     * of the mass matrix.
+                                     * assembled exactly using
+                                     * MatrixTools::create_mass_matrix. This
+                                     * function performs numerical
+                                     * quadrature using the given
+                                     * quadrature rule; you should
+                                     * therefore make sure that the
+                                     * given quadrature formula is
+                                     * also sufficient for the
+                                     * integration of the mass
+                                     * matrix.
                                      *
                                      * See the general documentation of this
                                      * class for further information.
@@ -841,7 +839,7 @@ class VectorTools
                                      * See the general documentation of this
                                      * class for more information.
                                      *
-                                     * @ref Instantiations: some
+                                     * @ref Instantiations : some
                                      * (InVectors as in the
                                      * documentation of the class,
                                      * OutVector only Vector<double>
index 0aada7e999e06546a11155508b9f76928d20925d..78e0715a845859f87c56373305a218f58d10aa6e 100644 (file)
@@ -557,7 +557,7 @@ class BlockTrianglePrecondition
 
 /*@}*/
 
-///@if NoDoc
+#ifndef DOXYGEN
 //---------------------------------------------------------------------------
 
 template <typename number>
@@ -689,6 +689,6 @@ BlockTrianglePrecondition<number>::enter (const MATRIX& matrix,
 
 
 
-///@endif
+#endif // DOXYGEN
 
 #endif
index f9d8ea21d50eab82b44cc01a27be5eff82e836bd..f3491c06274d3b5a7f2c57a57f1cf57193cfa58a 100644 (file)
@@ -269,7 +269,7 @@ namespace internal
  * you attempt anyway, you will likely get a number of compiler
  * errors.
  *
- * @ref Instantiations: some (<tt>@<float@> @<double@></tt>).
+ * @ref Instantiations : some (<tt>@<float@> @<double@></tt>).
  * @author Wolfgang Bangerth, 2000, 2004
  */
 template <typename MatrixType>
index 06901282b8208df99e6c31b4714efe227981b81f..3297279143812d14338cc5f36a4d39db5d61f9eb 100644 (file)
@@ -36,7 +36,7 @@
  * allocation of vectors and provides functions that are specific to the
  * underlying vector type.
  *
- * @ref Instantiations: some (<tt>@<float@> @<double@></tt>)
+ * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
  *
  * @author Wolfgang Bangerth, Guido Kanschat, 1999, 2000, 2001, 2002, 2004
  */
@@ -376,7 +376,7 @@ class BlockVector : public BlockVectorBase<Vector<Number> >
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 /*----------------------- Inline functions ----------------------------------*/
 
 
@@ -452,7 +452,7 @@ void BlockVector<Number>::scale (const BlockVector2 &v)
   BaseClass::scale (v);
 }
 
-///@endif
+#endif // DOXYGEN
 
 
 /*! @addtogroup Vectors
index 61fc3fdcab6544a4f577e313af6efb1b83c65065..0990742a1f78d5d49d0150c7870462d7a1e32a5d 100644 (file)
@@ -1007,7 +1007,7 @@ class BlockVectorBase
 /*----------------------- Inline functions ----------------------------------*/
 
 
-///@if NoDoc
+#ifndef DOXYGEN
 namespace internal
 {
   namespace BlockVectorIterators
@@ -2116,6 +2116,6 @@ BlockVectorBase<VectorType>::operator() (const unsigned int i)
   return components[local_index.first](local_index.second);
 }
 
-///@endif
+#endif // DOXYGEN
 
 #endif
index 83a8b3fe028b53529783e513af7c11acb0775899..2a47b1b4764d6f966e416ce8b076037f9ae52363 100644 (file)
@@ -46,7 +46,7 @@ template<typename number> class Vector;
  * vector argument to functions. If there is no argument with a number
  * type, the matrix number type is used.
  *
- * @ref Instantiations: some (<tt>@<float@> @<double@></tt>)
+ * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
  *
  * @author Guido Kanschat, Franz-Theo Suttmeier, Wolfgang Bangerth, 1993-2004
  */
@@ -445,7 +445,7 @@ class FullMatrix : public Table<2,number>
 
                                     /**
                                      * @deprecated Old name for
-                                     * frobenius_norm().
+                                     * FullMatrix::frobenius_norm().
                                      */
     number norm2 () const;
 
@@ -1062,7 +1062,7 @@ class FullMatrix : public Table<2,number>
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 /*-------------------------Inline functions -------------------------------*/
 
 
@@ -1315,7 +1315,7 @@ FullMatrix<number>::end (const unsigned int r) const
   return const_iterator(this, r+1, 0);
 }
 
-///@endif
+#endif // DOXYGEN
 
 #endif
 
index 3964c0951af81ffc3d7e6bc895f0bf79a2a5fed7..e8ea91230bd6d24dbc295e601478ae33dc3a6223 100644 (file)
@@ -38,7 +38,7 @@ template<typename number> class Vector;
  * compute the vector <i>x</i> minimizing <i>||Ax-b||</i> for a given
  * vector <i>b</i>.
  *
- * @ref Instantiations: some (<tt>@<float@> @<double@></tt>)
+ * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
  *
  * @author Guido Kanschat, 2005
  */
@@ -85,7 +85,7 @@ class Householder : private FullMatrix<number>
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 /*-------------------------Inline functions -------------------------------*/
 
 // QR-transformation cf. Stoer 1 4.8.2 (p. 191)
@@ -178,7 +178,7 @@ Householder<number>::least_squares (Vector<number2>& dst,
 
 
 
-///@endif
+#endif // DOXYGEN
 
 #endif
 
index d0bfbd7a5a9260b24bb7d9387161aa3d4234b60a..2a65cff8978dc2582ee13224adb9cbe8e1140f4a 100644 (file)
@@ -306,7 +306,7 @@ class MeanValueFilter : public Subscriptor
  * vmult_add() and Tvmult_add() start the iteration with a zero
  * vector.
  *
- * @ref Instantiations: some (Vector<float>, Vector<double>, BlockVector<float>, BlockVector<double>)
+ * @ref Instantiations : some (Vector<float>, Vector<double>, BlockVector<float>, BlockVector<double>)
  * @author Guido Kanschat, 2005
  */
 template<class VECTOR>
index 85aef06ff0cd3602db4c65681fca185e8b7fcedd..bdec2262253769cc7f9485666b1c2013769a56d8 100644 (file)
@@ -820,7 +820,7 @@ namespace PETScWrappers
 
 
 
-/// @if NoDoc
+#ifndef DOXYGEN
 // -------------------------- inline and template functions ----------------------
 
 
@@ -1044,7 +1044,7 @@ namespace PETScWrappers
             (index < static_cast<unsigned int>(end)));
   }
 
-/// @endif      
+#endif // DOXYGEN      
 }
 
 
index be845b49413f39d00b2aff2441ff43e80ccb45b2..2288f0de9b50e47cf331ddc32eeaabe429399384 100644 (file)
@@ -371,7 +371,7 @@ namespace PETScWrappers
     };
 
 
-/// @if NoDoc
+#ifndef DOXYGEN
 // ------------------ template and inline functions -------------
 
 
@@ -499,7 +499,7 @@ namespace PETScWrappers
       return communicator;
     }
 
-/// @endif
+#endif // DOXYGEN
   }
 }
 
index e036d178a198c6ddac029a7481fde1b534e744fc..75b7b47ea50af8c131da046ec5dc735da8dddbbf 100644 (file)
@@ -191,7 +191,7 @@ namespace PETScWrappers
   };
 
 
-/// @if NoDoc
+#ifndef DOXYGEN
 // ------------------ template and inline functions -------------
 
 
@@ -350,7 +350,7 @@ namespace PETScWrappers
 
     return *this;
   }
-/// @endif
+#endif // DOXYGEN
 
 }
 
index 833e1407dacad05935df798aab0fd62fdfd287e8..219605c41fb6e71790cd423107f9d50429272ba5 100644 (file)
@@ -685,7 +685,7 @@ namespace PETScWrappers
     u.swap (v);
   }
 
-///@if NoDoc
+#ifndef DOXYGEN
   namespace internal
   {
     inline
@@ -928,7 +928,7 @@ namespace PETScWrappers
   }
   
 
-///@endif
+#endif // DOXYGEN
 }
 
 #endif // DEAL_II_USE_PETSC
index a8985f43909c0f0de71631617fc7a0eedc5516e1..f15e059e329a8fda9a4a4666abccdda34cd4dfce 100644 (file)
@@ -75,7 +75,7 @@ class PreconditionIdentity : public Subscriptor
 /**
  * Preconditioning with Richardson's method. This preconditioner just
  * scales the vector with a constant relaxation factor provided by the
- * #AdditionalData object.
+ * AdditionalData object.
  *
  * In Krylov-space methods, this preconditioner should not have any
  * effect. Using SolverRichardson, the two relaxation parameters will
index b2b3c586c46ddb1dc8e4a7c1ae8f9776524486dc..5cbfef80ea31508636ebf0f5031615a2fff2d924 100644 (file)
@@ -406,7 +406,7 @@ class PreconditionBlock : public virtual Subscriptor
  * Block Jacobi preconditioning.
  * See PreconditionBlock for requirements on the matrix.
  *
- * @ref Instantiations: some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
+ * @ref Instantiations : some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2003
  */
 template<class MATRIX, typename inverse_type = typename MATRIX::value_type>
@@ -690,7 +690,7 @@ class PreconditionBlockJacobi : public virtual Subscriptor,
  * arbitrarily.
  *
  * See PreconditionBlock for requirements on the matrix.
- * @ref Instantiations: some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
+ * @ref Instantiations : some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2001, 2002, 2003
  */
 template<class MATRIX, typename inverse_type = typename MATRIX::value_type>
@@ -846,7 +846,7 @@ class PreconditionBlockSOR : public virtual Subscriptor,
  * class requires storage of the diagonal blocks and their inverses.
  *
  * See PreconditionBlock for requirements on the matrix.
- * @ref Instantiations: some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
+ * @ref Instantiations : some (SparseMatrix<double>, SparseMatrix<float>, <tt>double</tt>, <tt>float</tt>)
  * @author Ralf Hartmann, Guido Kanschat, 1999, 2000
  */
 template<class MATRIX, typename inverse_type = typename MATRIX::value_type>
index 9423fe4e8702ded10b0cf90ca3f30db7a44717c8..98627bc0559bf631fc7f830ed9da41c1a551c748 100644 (file)
@@ -234,6 +234,8 @@ class SolverBicgstab : public Solver<VECTOR>
 /*@}*/
 /*-------------------------Inline functions -------------------------------*/
 
+#ifndef DOXYGEN
+
 template<class VECTOR>
 SolverBicgstab<VECTOR>::SolverBicgstab (SolverControl &cn,
                                        VectorMemory<VECTOR> &mem,
@@ -405,5 +407,6 @@ SolverBicgstab<VECTOR>::solve(const MATRIX &A,
                                   // otherwise exit as normal
 }
 
+#endif // DOXYGEN
 
 #endif
index 104464d53a7718fcd1eef9191755ba57a808db48..671f678d0d4ad2c6012fe54bdbf617e0e1621693 100644 (file)
@@ -173,7 +173,7 @@ class SolverCG : public Solver<VECTOR>
 
 /*------------------------- Implementation ----------------------------*/
 
-
+#ifndef DOXYGEN
 
 template <class VECTOR>
 inline
@@ -340,4 +340,6 @@ SolverCG<VECTOR>::solve (const MATRIX         &A,
                                   // otherwise exit as normal
 }
 
+#endif // DOXYGEN
+
 #endif
index 8d654ef943cf16fad552287e6d133fa7c8e97ea3..b6c2284826ee41d402ddd15c66bcc271a14fb660 100644 (file)
@@ -458,6 +458,7 @@ class ReductionControl : public SolverControl
 /*@}*/
 //---------------------------------------------------------------------------
 
+#ifndef DOXYGEN
 
 inline unsigned int
 SolverControl::max_steps () const
@@ -561,4 +562,6 @@ ReductionControl::set_reduction (const double t)
   return old;
 }
 
+#endif // DOXYGEN
+
 #endif
index 5ce0428b4f6a440860c4ca1dd9cde510b4fd2108..1385fbe1121a64cdc00f5bea5385aedc715d5275 100644 (file)
@@ -146,6 +146,7 @@ class SolverMinRes : public Solver<VECTOR>
 /*@}*/
 /*------------------------- Implementation ----------------------------*/
 
+#ifndef DOXYGEN
 
 template<class VECTOR>
 SolverMinRes<VECTOR>::SolverMinRes (SolverControl &cn,
@@ -369,5 +370,6 @@ SolverMinRes<VECTOR>::solve (const MATRIX         &A,
                                   // otherwise exit as normal
 }
 
+#endif // DOXYGEN
 
 #endif
index 0e9558ca89a9da1a8cb488730c14ed84186924e2..f3df068bb8b87e03678a00c8b68cd0c2f8a6ccd9 100644 (file)
@@ -197,6 +197,7 @@ class SolverQMRS : public Solver<VECTOR>
 /*@}*/
 /*------------------------- Implementation ----------------------------*/
 
+#ifndef DOXYGEN
 
 template<class VECTOR>
 SolverQMRS<VECTOR>::SolverQMRS(SolverControl &cn,
@@ -385,5 +386,6 @@ SolverQMRS<VECTOR>::iterate(const MATRIX         &A,
   return false;
 }
 
+#endif // DOXYGEN
 
 #endif
index 2e7a8e5dc62b19739dfe688731cca9554bc2bc4a..f14a9456d230522bef5cba61038562ec2497d8d6 100644 (file)
@@ -176,7 +176,7 @@ class SolverRichardson : public Solver<VECTOR>
 /*@}*/
 /*----------------- Implementation of the Richardson Method ------------------*/
 
-
+#ifndef DOXYGEN
 
 template <class VECTOR>
 inline
@@ -350,5 +350,6 @@ SolverRichardson<VECTOR>::set_omega (const double om)
   additional_data.omega=om;
 }
 
+#endif // DOXYGEN
 
 #endif
index 7a053ce765652495920842a47ec982f8471a32f3..11a8f565714eb02556ca898de56371361305a128 100644 (file)
@@ -434,6 +434,8 @@ class SparseLUDecomposition : protected SparseMatrix<number>,
 /*@}*/
 //---------------------------------------------------------------------------
 
+#ifndef DOXYGEN
+
 template <typename number>
 inline number
 SparseLUDecomposition<number>::
@@ -479,4 +481,6 @@ SparseLUDecomposition<number>::AdditionalData::AdditionalData (
 {}
 
 
+#endif // DOXYGEN
+
 #endif // __deal2__sparse_decomposition_h
index 64f4af846c401e5cd133dcaa105991d7f074675c..e8175cc61294314f82b508023454b1ac4fdcd280 100644 (file)
@@ -51,7 +51,7 @@
  * Refer to SparseLUDecomposition documentation for suggested
  * usage and state management.
  *
- * @ref Instantiations: some (float, double)
+ * @ref Instantiations : some (float, double)
  * @author Wolfgang Bangerth, 1999, based on a similar implementation
  * by Malte Braack; unified interface: Ralf Hartmann
  */
index d178061b83944a4e10738eefd454dddccb9cfbb1..5d75fba37d4d78983c3af4218d4b9d2fd63becfa 100644 (file)
@@ -1653,7 +1653,7 @@ class SparseMatrix : public virtual Subscriptor
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 /*---------------------- Inline functions -----------------------------------*/
 
 
@@ -2318,7 +2318,7 @@ SparseMatrix<number>::end (const unsigned int r)
   return end();
 }
 
-/// @endif
+#endif // DOXYGEN
 
 
 /*----------------------------   sparse_matrix.h     ---------------------------*/
index 5d0df516fb7cfe5a2f76b0cd91f705f448184ca3..cd27fa1f6eafbc256f01c6ddeb276d10e677c4d0 100644 (file)
@@ -1371,6 +1371,9 @@ SparseMatrixEZ<number>::allocate (const unsigned int row,
   const unsigned int end = r.start + r.length;
 
   unsigned int i = r.start;
+                                  // If diagonal exists and this
+                                  // column is higher, start only
+                                  // after diagonal.
   if (r.diagonal != RowInfo::invalid_diagonal && col >= row)
     i += r.diagonal;
                                   // Find position of entry
@@ -1387,6 +1390,7 @@ SparseMatrixEZ<number>::allocate (const unsigned int row,
                                   // If no more space is available
                                   // for this row, insert new
                                   // elements into the vector.
+//TODO:[GK] We should not extend this row if i<end
   if (row != row_info.size()-1)
     {
       if (end >= row_info[row+1].start)
index 881948eb11fc1a361c2c0379569cecab3aa3bde2..ed9fdc348b36f16867c123ba6311fe27163744b1 100644 (file)
@@ -118,7 +118,7 @@ template <typename number> class SparseBlockVanka;
  * whether this might pose some problems in the inversion of the local matrices.
  * Maybe someone would like to check this.
  *
- * @ref Instantiations: some (float, double)
+ * @ref Instantiations : some (float, double)
  * @author Guido Kanschat, Wolfgang Bangerth; 1999, 2000
  */
 template<typename number>
index aca6012cb0deee8af92d7df8201fb61ba85ae4bb..adeb642625a608c2e2121a1effeaf94f024656fe 100644 (file)
@@ -1563,7 +1563,7 @@ class SparsityPattern : public Subscriptor
 /*@}*/
 /*---------------------- Inline functions -----------------------------------*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 
 
 namespace internals
@@ -2091,6 +2091,6 @@ SparsityPattern::copy_from (const unsigned int    n_rows,
 }
 
 
-/// @endif
+#endif // DOXYGEN
 
 #endif
index ffe8195fa910267bad9a64d157d7b19ee5f6344e..dcb201827f0b03def57c4c0db8c86103ff2b6c04 100644 (file)
@@ -41,7 +41,7 @@
  * @p reload is called. If it is not available, @p reload waits until
  * the detached thread has loaded the data.
  *
- * @ref Instantiations: some (<tt>@<float@> @<double@></tt>)
+ * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
  * @author Wolfgang Bangerth, 1999, 2000
  */
 template <typename number>
index 43a92d4ca8f969acf9a383707111f1ea397a6997..0ff4bb58cb112947fc8dbdc6f57e719594081a22 100644 (file)
@@ -338,7 +338,7 @@ class TridiagonalMatrix
 };
 
 //---------------------------------------------------------------------------
-///@if NoDoc
+#ifndef DOXYGEN
 
 template<typename number>
 unsigned int
@@ -399,7 +399,7 @@ TridiagonalMatrix<number>::operator()(unsigned int i, unsigned int j)
 }
 
 
-///@endif
+#endif // DOXYGEN
 
 #endif
 
index e0c112a553af11f6ae777eb1f41e82024818543e..630017866f75160e9f658121000f2162d9af6f79 100644 (file)
@@ -48,7 +48,7 @@ template<typename number> class LAPACKFullMatrix;
  * @p vector (with a lowercase "v"), this class implements an element
  * of a vector space suitable for numerical computations.
  *
- * @ref Instantiations: some (<tt>@<float@> @<double@></tt>)
+ * @ref Instantiations : some (<tt>@<float@> @<double@></tt>)
  * @author Guido Kanschat, Franz-Theo Suttmeier, Wolfgang Bangerth
  */
 template <typename Number>
index 4fef26effb4320d0782b649ee3a45cbd2b1f97c9..acc515870a8708da40d2092067f0280de8b6ec04 100644 (file)
@@ -194,7 +194,7 @@ class GrowingVectorMemory : public VectorMemory<VECTOR>
 
 /*@}*/
 
-/// @if NoDoc
+#ifndef DOXYGEN
 /* --------------------- inline functions ---------------------- */
 
 
@@ -304,6 +304,6 @@ GrowingVectorMemory<VECTOR>::memory_consumption () const
   return result;
 }
 
-///@endif
+#endif // DOXYGEN
 
 #endif

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.