From: guido Date: Tue, 30 Aug 2005 17:41:55 +0000 (+0000) Subject: new DOXYGEN conditional and adaption to doxygen 1.4 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=28c9725b46081e69aef75a59a8913e7f874a6088;p=dealii-svn.git new DOXYGEN conditional and adaption to doxygen 1.4 git-svn-id: https://svn.dealii.org/trunk@11349 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/base/include/base/function_parser.h b/deal.II/base/include/base/function_parser.h index d96b0da535..9e9ed55b19 100644 --- a/deal.II/base/include/base/function_parser.h +++ b/deal.II/base/include/base/function_parser.h @@ -308,7 +308,7 @@ class FunctionParser : public Function * 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 time_dependent parameter * to true. An exception is thrown if * the number of variables specified here * is different from dim (if this diff --git a/deal.II/base/include/base/geometry_info.h b/deal.II/base/include/base/geometry_info.h index a9aed587f7..606fa6c2b5 100644 --- a/deal.II/base/include/base/geometry_info.h +++ b/deal.II/base/include/base/geometry_info.h @@ -32,7 +32,7 @@ template 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 @@ -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 diff --git a/deal.II/base/include/base/memory_consumption.h b/deal.II/base/include/base/memory_consumption.h index 613b3f5e45..d9f8da7af9 100644 --- a/deal.II/base/include/base/memory_consumption.h +++ b/deal.II/base/include/base/memory_consumption.h @@ -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 diff --git a/deal.II/base/include/base/multithread_info.h b/deal.II/base/include/base/multithread_info.h index f0e762bd71..c606af2539 100644 --- a/deal.II/base/include/base/multithread_info.h +++ b/deal.II/base/include/base/multithread_info.h @@ -59,7 +59,7 @@ class MultithreadInfo * machine, please refer to the * documentation in * multithread_info.cc - * near to the #error directive. + * near to the error directive. */ const unsigned int n_cpus; diff --git a/deal.II/base/include/base/point.h b/deal.II/base/include/base/point.h index fda71c498a..83fdaa2c16 100644 --- a/deal.II/base/include/base/point.h +++ b/deal.II/base/include/base/point.h @@ -195,6 +195,7 @@ class Point : public Tensor<1,dim> /*------------------------------- Inline functions: Point ---------------------------*/ +#ifndef DOXYGEN template inline @@ -355,6 +356,7 @@ Point Point::operator / (const double factor) const return (Point(*this) /= factor); } +#endif // DOXYGEN /*------------------------------- Global functions: Point ---------------------------*/ @@ -362,6 +364,7 @@ Point Point::operator / (const double factor) const /** * Global operator scaling a point vector by a scalar. + * @relates Point */ template inline @@ -374,6 +377,7 @@ Point operator * (const double factor, const Point &p) /** * Output operator for points. Print the elements consecutively, * with a space in between. + * @relates Point */ template 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 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 diff --git a/deal.II/base/include/base/polynomial_space.h b/deal.II/base/include/base/polynomial_space.h index 08a7a43bf9..af46c6d734 100644 --- a/deal.II/base/include/base/polynomial_space.h +++ b/deal.II/base/include/base/polynomial_space.h @@ -251,7 +251,6 @@ class PolynomialSpace std::vector index_map_inverse; }; -/// @if NoDoc /* -------------- declaration of explicit specializations --- */ @@ -327,6 +326,4 @@ PolynomialSpace::output_indices(STREAM &out) const -/// @endif - #endif diff --git a/deal.II/base/include/base/qprojector.h b/deal.II/base/include/base/qprojector.h index 65c269dcc2..a4232e56c1 100644 --- a/deal.II/base/include/base/qprojector.h +++ b/deal.II/base/include/base/qprojector.h @@ -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 diff --git a/deal.II/base/include/base/quadrature.h b/deal.II/base/include/base/quadrature.h index af45cce0fa..7d4273ff3a 100644 --- a/deal.II/base/include/base/quadrature.h +++ b/deal.II/base/include/base/quadrature.h @@ -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 /*@}*/ -/// @if NoDoc +#ifndef DOXYGEN /* -------------- declaration of explicit specializations ------------- */ @@ -343,6 +343,6 @@ double Quadrature<0>::weight (const unsigned int) const; template <> const std::vector & Quadrature<0>::get_weights () const; -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/base/include/base/smartpointer.h b/deal.II/base/include/base/smartpointer.h index ee877835d1..b0b545b559 100644 --- a/deal.II/base/include/base/smartpointer.h +++ b/deal.II/base/include/base/smartpointer.h @@ -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). */ diff --git a/deal.II/base/include/base/symmetric_tensor.h b/deal.II/base/include/base/symmetric_tensor.h index 138ee6a2e4..b61da79d55 100644 --- a/deal.II/base/include/base/symmetric_tensor.h +++ b/deal.II/base/include/base/symmetric_tensor.h @@ -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. ------------ */ diff --git a/deal.II/base/include/base/table.h b/deal.II/base/include/base/table.h index 41b68089f1..141ee3634a 100644 --- a/deal.II/base/include/base/table.h +++ b/deal.II/base/include/base/table.h @@ -1563,9 +1563,10 @@ class Table<7,T> : public TableBase<7,T> }; -///@if NoDoc + /* --------------------- Template and inline functions ---------------- */ +#ifndef DOXYGEN template TableBase::TableBase () @@ -2851,6 +2852,6 @@ Table<7,T>::operator () (const unsigned int i, *this->table_size[6] + o]; } -///@endif +#endif // DOXYGEN #endif diff --git a/deal.II/base/include/base/tensor.h b/deal.II/base/include/base/tensor.h index a8df8cc730..73dd8bba2a 100644 --- a/deal.II/base/include/base/tensor.h +++ b/deal.II/base/include/base/tensor.h @@ -255,7 +255,7 @@ class Tensor /*--------------------------- Inline functions -----------------------------*/ -/// @if NoDoc +#ifndef DOXYGEN template inline @@ -456,7 +456,7 @@ Tensor::memory_consumption () return sizeof(Tensor); } -/// @endif +#endif // DOXYGEN /* ----------------- Non-member functions operating on tensors. ------------ */ @@ -477,6 +477,7 @@ std::ostream & operator << (std::ostream &out, const Tensor &p) return out; } +#ifndef DOXYGEN /** * Specialization for 1D. @@ -490,6 +491,7 @@ std::ostream & operator << (std::ostream &out, const Tensor &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 /** diff --git a/deal.II/base/include/base/tensor_base.h b/deal.II/base/include/base/tensor_base.h index 566e55a297..d35e4b9977 100644 --- a/deal.II/base/include/base/tensor_base.h +++ b/deal.II/base/include/base/tensor_base.h @@ -359,7 +359,7 @@ class Tensor<1,dim> template 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 diff --git a/deal.II/base/include/base/tensor_product_polynomials.h b/deal.II/base/include/base/tensor_product_polynomials.h index d079f930c8..55bc88a685 100644 --- a/deal.II/base/include/base/tensor_product_polynomials.h +++ b/deal.II/base/include/base/tensor_product_polynomials.h @@ -262,7 +262,7 @@ class TensorProductPolynomials unsigned int x_to_the_dim (const unsigned int x); }; -/// @if NoDoc +#ifndef DOXYGEN template inline @@ -282,7 +282,7 @@ TensorProductPolynomials::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 diff --git a/deal.II/base/include/base/thread_management.h b/deal.II/base/include/base/thread_management.h index 0b03caa979..6aad91550c 100644 --- a/deal.II/base/include/base/thread_management.h +++ b/deal.II/base/include/base/thread_management.h @@ -758,7 +758,7 @@ namespace Threads } // end declarations of namespace Threads /* ----------- implementation of functions in namespace Threads ---------- */ -/// @if NoDoc +#ifndef DOXYGEN namespace Threads { template @@ -820,7 +820,7 @@ namespace Threads } } -///@endif +#endif // DOXYGEN namespace Threads { diff --git a/deal.II/base/include/base/utilities.h b/deal.II/base/include/base/utilities.h index 713190d4a3..a3f66a3ac2 100644 --- a/deal.II/base/include/base/utilities.h +++ b/deal.II/base/include/base/utilities.h @@ -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, diff --git a/deal.II/base/include/base/vector_slice.h b/deal.II/base/include/base/vector_slice.h index f16d894b8b..3f45bc9c63 100644 --- a/deal.II/base/include/base/vector_slice.h +++ b/deal.II/base/include/base/vector_slice.h @@ -76,7 +76,7 @@ class VectorSlice * using the same interface as * std::vector. */ - 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 * std::vector. */ - typename VECTOR::const_reference operator[] (unsigned int) const; + typename VECTOR::const_reference operator[] (unsigned int i) const; private: /** * The vector we extract from. diff --git a/deal.II/deal.II/include/dofs/dof_handler.h b/deal.II/deal.II/include/dofs/dof_handler.h index 0aed877576..a2fe4b2187 100644 --- a/deal.II/deal.II/include/dofs/dof_handler.h +++ b/deal.II/deal.II/include/dofs/dof_handler.h @@ -39,11 +39,11 @@ template 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 */ diff --git a/deal.II/deal.II/include/dofs/dof_tools.h b/deal.II/deal.II/include/dofs/dof_tools.h index 0e5245033c..eefc4f7c23 100644 --- a/deal.II/deal.II/include/dofs/dof_tools.h +++ b/deal.II/deal.II/include/dofs/dof_tools.h @@ -115,11 +115,11 @@ template 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 diff --git a/deal.II/deal.II/include/fe/fe_dgp.h b/deal.II/deal.II/include/fe/fe_dgp.h index 8952194add..3a8df6724a 100644 --- a/deal.II/deal.II/include/fe/fe_dgp.h +++ b/deal.II/deal.II/include/fe/fe_dgp.h @@ -155,7 +155,7 @@ class FE_DGP : public FE_Poly,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 diff --git a/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h b/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h index 0b7fab8400..f2a489a86c 100644 --- a/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h +++ b/deal.II/deal.II/include/fe/fe_dgp_nonparametric.h @@ -442,7 +442,7 @@ class FE_DGPNonparametric : public FiniteElement /*@}*/ -/// @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 diff --git a/deal.II/deal.II/include/fe/fe_nedelec.h b/deal.II/deal.II/include/fe/fe_nedelec.h index c316a6e8c8..e43b19c94b 100644 --- a/deal.II/deal.II/include/fe/fe_nedelec.h +++ b/deal.II/deal.II/include/fe/fe_nedelec.h @@ -607,7 +607,7 @@ class FE_Nedelec : public FiniteElement /*@}*/ -/// @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 diff --git a/deal.II/deal.II/include/fe/fe_raviart_thomas.h b/deal.II/deal.II/include/fe/fe_raviart_thomas.h index f8f3905150..d01d299ac0 100644 --- a/deal.II/deal.II/include/fe/fe_raviart_thomas.h +++ b/deal.II/deal.II/include/fe/fe_raviart_thomas.h @@ -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 &) const; -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index b32aeaf8ad..873314ac17 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -2202,7 +2202,7 @@ class FESubfaceValues : public FEFaceValuesBase /*@}*/ -///@if NoDoc +#ifndef DOXYGEN /*------------------------ Inline functions: FEValuesBase ------------------------*/ @@ -2651,7 +2651,7 @@ FEFaceValuesBase::boundary_form (const unsigned int i) const return this->boundary_forms[i]; } -///@endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/fe/mapping_c1.h b/deal.II/deal.II/include/fe/mapping_c1.h index 2cff467726..d7405a65c3 100644 --- a/deal.II/deal.II/include/fe/mapping_c1.h +++ b/deal.II/deal.II/include/fe/mapping_c1.h @@ -108,7 +108,7 @@ class MappingC1 : public MappingQ /* -------------- 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 > &) const; -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/fe/mapping_cartesian.h b/deal.II/deal.II/include/fe/mapping_cartesian.h index 3db7e6fdda..716ca732a8 100644 --- a/deal.II/deal.II/include/fe/mapping_cartesian.h +++ b/deal.II/deal.II/include/fe/mapping_cartesian.h @@ -213,7 +213,7 @@ class MappingCartesian : public Mapping /* -------------- 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 >&, std::vector >&) const; -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/fe/mapping_q.h b/deal.II/deal.II/include/fe/mapping_q.h index 328b633941..8de37b52b1 100644 --- a/deal.II/deal.II/include/fe/mapping_q.h +++ b/deal.II/deal.II/include/fe/mapping_q.h @@ -518,7 +518,7 @@ class MappingQ : public MappingQ1 /* -------------- 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 > &a) const; -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/fe/mapping_q1.h b/deal.II/deal.II/include/fe/mapping_q1.h index 525411f8e3..286a826e7b 100644 --- a/deal.II/deal.II/include/fe/mapping_q1.h +++ b/deal.II/deal.II/include/fe/mapping_q1.h @@ -667,7 +667,7 @@ MappingQ1::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 >&, std::vector >&) const; -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/grid/grid_in.h b/deal.II/deal.II/include/grid/grid_in.h index 87adb544a2..0c9330f767 100644 --- a/deal.II/deal.II/include/grid/grid_in.h +++ b/deal.II/deal.II/include/grid/grid_in.h @@ -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 > &cells, const std::vector > &vertices, std::ostream &out); -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/grid/tria.h b/deal.II/deal.II/include/grid/tria.h index 6faee8b0fb..881d7239d2 100644 --- a/deal.II/deal.II/include/grid/tria.h +++ b/deal.II/deal.II/include/grid/tria.h @@ -33,6 +33,7 @@ template 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 diff --git a/deal.II/deal.II/include/grid/tria_accessor.h b/deal.II/deal.II/include/grid/tria_accessor.h index 8020796c75..5fb17917d7 100644 --- a/deal.II/deal.II/include/grid/tria_accessor.h +++ b/deal.II/deal.II/include/grid/tria_accessor.h @@ -2723,7 +2723,7 @@ class CellAccessor : public TriaObjectAccessor /* -------------- 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 diff --git a/deal.II/deal.II/include/grid/tria_boundary.h b/deal.II/deal.II/include/grid/tria_boundary.h index c9b5dbdf46..2f4365f2a8 100644 --- a/deal.II/deal.II/include/grid/tria_boundary.h +++ b/deal.II/deal.II/include/grid/tria_boundary.h @@ -358,7 +358,7 @@ class StraightBoundary : public Boundary /* -------------- 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 > &points) const; -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/grid/tria_boundary_lib.h b/deal.II/deal.II/include/grid/tria_boundary_lib.h index 638804b62f..c4e415d603 100644 --- a/deal.II/deal.II/include/grid/tria_boundary_lib.h +++ b/deal.II/deal.II/include/grid/tria_boundary_lib.h @@ -496,7 +496,7 @@ class HalfHyperShellBoundary : public HyperShellBoundary /* -------------- 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 diff --git a/deal.II/deal.II/include/grid/tria_iterator.h b/deal.II/deal.II/include/grid/tria_iterator.h index 9707388df1..35cc0849f5 100644 --- a/deal.II/deal.II/include/grid/tria_iterator.h +++ b/deal.II/deal.II/include/grid/tria_iterator.h @@ -205,7 +205,7 @@ template 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 + * before-the-start 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 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 diff --git a/deal.II/deal.II/include/multigrid/mg_block_smoother.h b/deal.II/deal.II/include/multigrid/mg_block_smoother.h index f01549256b..c6f8dda9d0 100644 --- a/deal.II/deal.II/include/multigrid/mg_block_smoother.h +++ b/deal.II/deal.II/include/multigrid/mg_block_smoother.h @@ -179,6 +179,8 @@ class MGSmootherBlock //--------------------------------------------------------------------------- +#ifndef DOXYGEN + template inline MGSmootherBlock::MGSmootherBlock( @@ -328,6 +330,6 @@ MGSmootherBlock::smooth( deallog.pop(); } - +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/multigrid/mg_coarse.h b/deal.II/deal.II/include/multigrid/mg_coarse.h index d64e241eb4..3ea09baf49 100644 --- a/deal.II/deal.II/include/multigrid/mg_coarse.h +++ b/deal.II/deal.II/include/multigrid/mg_coarse.h @@ -173,7 +173,7 @@ class MGCoarseGridHouseholder : public MGCoarseGridBase /*@}*/ -/// @if NoDoc +#ifndef DOXYGEN /* ------------------ Functions for MGCoarseGridLACIteration ------------ */ @@ -309,6 +309,6 @@ MGCoarseGridHouseholder::operator() ( work.least_squares(dst, aux); } -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/multigrid/mg_smoother.h b/deal.II/deal.II/include/multigrid/mg_smoother.h index cbc91195a6..c1c4f112e5 100644 --- a/deal.II/deal.II/include/multigrid/mg_smoother.h +++ b/deal.II/deal.II/include/multigrid/mg_smoother.h @@ -373,6 +373,8 @@ class MGSmootherRelaxation : public MGSmootherBase /* ------------------------------- Inline functions -------------------------- */ +#ifndef DOXYGEN + template inline void MGSmootherIdentity::smooth ( @@ -582,5 +584,6 @@ memory_consumption () const } +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/multigrid/multigrid.h b/deal.II/deal.II/include/multigrid/multigrid.h index a28eb4b136..ed612cd6e0 100644 --- a/deal.II/deal.II/include/multigrid/multigrid.h +++ b/deal.II/deal.II/include/multigrid/multigrid.h @@ -507,7 +507,7 @@ class PreconditionMG : public Subscriptor /*@}*/ -/// @if NoDoc +#ifndef DOXYGEN /* --------------------------- inline functions --------------------- */ @@ -635,6 +635,6 @@ PreconditionMG::Tvmult_add ( Assert(false, ExcNotImplemented()); } -/// @endif +#endif // DOXYGEN #endif diff --git a/deal.II/deal.II/include/numerics/data_out.h b/deal.II/deal.II/include/numerics/data_out.h index 3c4471d8a9..5513190b67 100644 --- a/deal.II/deal.II/include/numerics/data_out.h +++ b/deal.II/deal.II/include/numerics/data_out.h @@ -934,7 +934,7 @@ class DataOut : public DataOut_DoFData * 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 * [i][j] the number of the * patch that associated with the diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index 2b37acf61a..73cd10f164 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -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, Vector, BlockVector, BlockVector, see also individual functions) + * @ref Instantiations : some (Vector, Vector, BlockVector, BlockVector, 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. + * @p 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 diff --git a/deal.II/lac/include/lac/block_matrix_array.h b/deal.II/lac/include/lac/block_matrix_array.h index 0aada7e999..78e0715a84 100644 --- a/deal.II/lac/include/lac/block_matrix_array.h +++ b/deal.II/lac/include/lac/block_matrix_array.h @@ -557,7 +557,7 @@ class BlockTrianglePrecondition /*@}*/ -///@if NoDoc +#ifndef DOXYGEN //--------------------------------------------------------------------------- template @@ -689,6 +689,6 @@ BlockTrianglePrecondition::enter (const MATRIX& matrix, -///@endif +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/block_matrix_base.h b/deal.II/lac/include/lac/block_matrix_base.h index f9d8ea21d5..f3491c0627 100644 --- a/deal.II/lac/include/lac/block_matrix_base.h +++ b/deal.II/lac/include/lac/block_matrix_base.h @@ -269,7 +269,7 @@ namespace internal * you attempt anyway, you will likely get a number of compiler * errors. * - * @ref Instantiations: some (@ @). + * @ref Instantiations : some (@ @). * @author Wolfgang Bangerth, 2000, 2004 */ template diff --git a/deal.II/lac/include/lac/block_vector.h b/deal.II/lac/include/lac/block_vector.h index 06901282b8..3297279143 100644 --- a/deal.II/lac/include/lac/block_vector.h +++ b/deal.II/lac/include/lac/block_vector.h @@ -36,7 +36,7 @@ * allocation of vectors and provides functions that are specific to the * underlying vector type. * - * @ref Instantiations: some (@ @) + * @ref Instantiations : some (@ @) * * @author Wolfgang Bangerth, Guido Kanschat, 1999, 2000, 2001, 2002, 2004 */ @@ -376,7 +376,7 @@ class BlockVector : public BlockVectorBase > /*@}*/ -/// @if NoDoc +#ifndef DOXYGEN /*----------------------- Inline functions ----------------------------------*/ @@ -452,7 +452,7 @@ void BlockVector::scale (const BlockVector2 &v) BaseClass::scale (v); } -///@endif +#endif // DOXYGEN /*! @addtogroup Vectors diff --git a/deal.II/lac/include/lac/block_vector_base.h b/deal.II/lac/include/lac/block_vector_base.h index 61fc3fdcab..0990742a1f 100644 --- a/deal.II/lac/include/lac/block_vector_base.h +++ b/deal.II/lac/include/lac/block_vector_base.h @@ -1007,7 +1007,7 @@ class BlockVectorBase /*----------------------- Inline functions ----------------------------------*/ -///@if NoDoc +#ifndef DOXYGEN namespace internal { namespace BlockVectorIterators @@ -2116,6 +2116,6 @@ BlockVectorBase::operator() (const unsigned int i) return components[local_index.first](local_index.second); } -///@endif +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/full_matrix.h b/deal.II/lac/include/lac/full_matrix.h index 83a8b3fe02..2a47b1b476 100644 --- a/deal.II/lac/include/lac/full_matrix.h +++ b/deal.II/lac/include/lac/full_matrix.h @@ -46,7 +46,7 @@ template class Vector; * vector argument to functions. If there is no argument with a number * type, the matrix number type is used. * - * @ref Instantiations: some (@ @) + * @ref Instantiations : some (@ @) * * @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::end (const unsigned int r) const return const_iterator(this, r+1, 0); } -///@endif +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/householder.h b/deal.II/lac/include/lac/householder.h index 3964c0951a..e8ea91230b 100644 --- a/deal.II/lac/include/lac/householder.h +++ b/deal.II/lac/include/lac/householder.h @@ -38,7 +38,7 @@ template class Vector; * compute the vector x minimizing ||Ax-b|| for a given * vector b. * - * @ref Instantiations: some (@ @) + * @ref Instantiations : some (@ @) * * @author Guido Kanschat, 2005 */ @@ -85,7 +85,7 @@ class Householder : private FullMatrix /*@}*/ -/// @if NoDoc +#ifndef DOXYGEN /*-------------------------Inline functions -------------------------------*/ // QR-transformation cf. Stoer 1 4.8.2 (p. 191) @@ -178,7 +178,7 @@ Householder::least_squares (Vector& dst, -///@endif +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/matrix_lib.h b/deal.II/lac/include/lac/matrix_lib.h index d0bfbd7a5a..2a65cff897 100644 --- a/deal.II/lac/include/lac/matrix_lib.h +++ b/deal.II/lac/include/lac/matrix_lib.h @@ -306,7 +306,7 @@ class MeanValueFilter : public Subscriptor * vmult_add() and Tvmult_add() start the iteration with a zero * vector. * - * @ref Instantiations: some (Vector, Vector, BlockVector, BlockVector) + * @ref Instantiations : some (Vector, Vector, BlockVector, BlockVector) * @author Guido Kanschat, 2005 */ template diff --git a/deal.II/lac/include/lac/petsc_matrix_base.h b/deal.II/lac/include/lac/petsc_matrix_base.h index 85aef06ff0..bdec226225 100644 --- a/deal.II/lac/include/lac/petsc_matrix_base.h +++ b/deal.II/lac/include/lac/petsc_matrix_base.h @@ -820,7 +820,7 @@ namespace PETScWrappers -/// @if NoDoc +#ifndef DOXYGEN // -------------------------- inline and template functions ---------------------- @@ -1044,7 +1044,7 @@ namespace PETScWrappers (index < static_cast(end))); } -/// @endif +#endif // DOXYGEN } diff --git a/deal.II/lac/include/lac/petsc_parallel_vector.h b/deal.II/lac/include/lac/petsc_parallel_vector.h index be845b4941..2288f0de9b 100644 --- a/deal.II/lac/include/lac/petsc_parallel_vector.h +++ b/deal.II/lac/include/lac/petsc_parallel_vector.h @@ -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 } } diff --git a/deal.II/lac/include/lac/petsc_vector.h b/deal.II/lac/include/lac/petsc_vector.h index e036d178a1..75b7b47ea5 100644 --- a/deal.II/lac/include/lac/petsc_vector.h +++ b/deal.II/lac/include/lac/petsc_vector.h @@ -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 } diff --git a/deal.II/lac/include/lac/petsc_vector_base.h b/deal.II/lac/include/lac/petsc_vector_base.h index 833e1407da..219605c41f 100644 --- a/deal.II/lac/include/lac/petsc_vector_base.h +++ b/deal.II/lac/include/lac/petsc_vector_base.h @@ -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 diff --git a/deal.II/lac/include/lac/precondition.h b/deal.II/lac/include/lac/precondition.h index a8985f4390..f15e059e32 100644 --- a/deal.II/lac/include/lac/precondition.h +++ b/deal.II/lac/include/lac/precondition.h @@ -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 diff --git a/deal.II/lac/include/lac/precondition_block.h b/deal.II/lac/include/lac/precondition_block.h index b2b3c586c4..5cbfef80ea 100644 --- a/deal.II/lac/include/lac/precondition_block.h +++ b/deal.II/lac/include/lac/precondition_block.h @@ -406,7 +406,7 @@ class PreconditionBlock : public virtual Subscriptor * Block Jacobi preconditioning. * See PreconditionBlock for requirements on the matrix. * - * @ref Instantiations: some (SparseMatrix, SparseMatrix, double, float) + * @ref Instantiations : some (SparseMatrix, SparseMatrix, double, float) * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2003 */ template @@ -690,7 +690,7 @@ class PreconditionBlockJacobi : public virtual Subscriptor, * arbitrarily. * * See PreconditionBlock for requirements on the matrix. - * @ref Instantiations: some (SparseMatrix, SparseMatrix, double, float) + * @ref Instantiations : some (SparseMatrix, SparseMatrix, double, float) * @author Ralf Hartmann, Guido Kanschat, 1999, 2000, 2001, 2002, 2003 */ template @@ -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, SparseMatrix, double, float) + * @ref Instantiations : some (SparseMatrix, SparseMatrix, double, float) * @author Ralf Hartmann, Guido Kanschat, 1999, 2000 */ template diff --git a/deal.II/lac/include/lac/solver_bicgstab.h b/deal.II/lac/include/lac/solver_bicgstab.h index 9423fe4e87..98627bc055 100644 --- a/deal.II/lac/include/lac/solver_bicgstab.h +++ b/deal.II/lac/include/lac/solver_bicgstab.h @@ -234,6 +234,8 @@ class SolverBicgstab : public Solver /*@}*/ /*-------------------------Inline functions -------------------------------*/ +#ifndef DOXYGEN + template SolverBicgstab::SolverBicgstab (SolverControl &cn, VectorMemory &mem, @@ -405,5 +407,6 @@ SolverBicgstab::solve(const MATRIX &A, // otherwise exit as normal } +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/solver_cg.h b/deal.II/lac/include/lac/solver_cg.h index 104464d53a..671f678d0d 100644 --- a/deal.II/lac/include/lac/solver_cg.h +++ b/deal.II/lac/include/lac/solver_cg.h @@ -173,7 +173,7 @@ class SolverCG : public Solver /*------------------------- Implementation ----------------------------*/ - +#ifndef DOXYGEN template inline @@ -340,4 +340,6 @@ SolverCG::solve (const MATRIX &A, // otherwise exit as normal } +#endif // DOXYGEN + #endif diff --git a/deal.II/lac/include/lac/solver_control.h b/deal.II/lac/include/lac/solver_control.h index 8d654ef943..b6c2284826 100644 --- a/deal.II/lac/include/lac/solver_control.h +++ b/deal.II/lac/include/lac/solver_control.h @@ -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 diff --git a/deal.II/lac/include/lac/solver_minres.h b/deal.II/lac/include/lac/solver_minres.h index 5ce0428b4f..1385fbe112 100644 --- a/deal.II/lac/include/lac/solver_minres.h +++ b/deal.II/lac/include/lac/solver_minres.h @@ -146,6 +146,7 @@ class SolverMinRes : public Solver /*@}*/ /*------------------------- Implementation ----------------------------*/ +#ifndef DOXYGEN template SolverMinRes::SolverMinRes (SolverControl &cn, @@ -369,5 +370,6 @@ SolverMinRes::solve (const MATRIX &A, // otherwise exit as normal } +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/solver_qmrs.h b/deal.II/lac/include/lac/solver_qmrs.h index 0e9558ca89..f3df068bb8 100644 --- a/deal.II/lac/include/lac/solver_qmrs.h +++ b/deal.II/lac/include/lac/solver_qmrs.h @@ -197,6 +197,7 @@ class SolverQMRS : public Solver /*@}*/ /*------------------------- Implementation ----------------------------*/ +#ifndef DOXYGEN template SolverQMRS::SolverQMRS(SolverControl &cn, @@ -385,5 +386,6 @@ SolverQMRS::iterate(const MATRIX &A, return false; } +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/solver_richardson.h b/deal.II/lac/include/lac/solver_richardson.h index 2e7a8e5dc6..f14a9456d2 100644 --- a/deal.II/lac/include/lac/solver_richardson.h +++ b/deal.II/lac/include/lac/solver_richardson.h @@ -176,7 +176,7 @@ class SolverRichardson : public Solver /*@}*/ /*----------------- Implementation of the Richardson Method ------------------*/ - +#ifndef DOXYGEN template inline @@ -350,5 +350,6 @@ SolverRichardson::set_omega (const double om) additional_data.omega=om; } +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/sparse_decomposition.h b/deal.II/lac/include/lac/sparse_decomposition.h index 7a053ce765..11a8f56571 100644 --- a/deal.II/lac/include/lac/sparse_decomposition.h +++ b/deal.II/lac/include/lac/sparse_decomposition.h @@ -434,6 +434,8 @@ class SparseLUDecomposition : protected SparseMatrix, /*@}*/ //--------------------------------------------------------------------------- +#ifndef DOXYGEN + template inline number SparseLUDecomposition:: @@ -479,4 +481,6 @@ SparseLUDecomposition::AdditionalData::AdditionalData ( {} +#endif // DOXYGEN + #endif // __deal2__sparse_decomposition_h diff --git a/deal.II/lac/include/lac/sparse_ilu.h b/deal.II/lac/include/lac/sparse_ilu.h index 64f4af846c..e8175cc612 100644 --- a/deal.II/lac/include/lac/sparse_ilu.h +++ b/deal.II/lac/include/lac/sparse_ilu.h @@ -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 */ diff --git a/deal.II/lac/include/lac/sparse_matrix.h b/deal.II/lac/include/lac/sparse_matrix.h index d178061b83..5d75fba37d 100644 --- a/deal.II/lac/include/lac/sparse_matrix.h +++ b/deal.II/lac/include/lac/sparse_matrix.h @@ -1653,7 +1653,7 @@ class SparseMatrix : public virtual Subscriptor /*@}*/ -/// @if NoDoc +#ifndef DOXYGEN /*---------------------- Inline functions -----------------------------------*/ @@ -2318,7 +2318,7 @@ SparseMatrix::end (const unsigned int r) return end(); } -/// @endif +#endif // DOXYGEN /*---------------------------- sparse_matrix.h ---------------------------*/ diff --git a/deal.II/lac/include/lac/sparse_matrix_ez.h b/deal.II/lac/include/lac/sparse_matrix_ez.h index 5d0df516fb..cd27fa1f6e 100644 --- a/deal.II/lac/include/lac/sparse_matrix_ez.h +++ b/deal.II/lac/include/lac/sparse_matrix_ez.h @@ -1371,6 +1371,9 @@ SparseMatrixEZ::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::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= row_info[row+1].start) diff --git a/deal.II/lac/include/lac/sparse_vanka.h b/deal.II/lac/include/lac/sparse_vanka.h index 881948eb11..ed9fdc348b 100644 --- a/deal.II/lac/include/lac/sparse_vanka.h +++ b/deal.II/lac/include/lac/sparse_vanka.h @@ -118,7 +118,7 @@ template 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 diff --git a/deal.II/lac/include/lac/sparsity_pattern.h b/deal.II/lac/include/lac/sparsity_pattern.h index aca6012cb0..adeb642625 100644 --- a/deal.II/lac/include/lac/sparsity_pattern.h +++ b/deal.II/lac/include/lac/sparsity_pattern.h @@ -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 diff --git a/deal.II/lac/include/lac/swappable_vector.h b/deal.II/lac/include/lac/swappable_vector.h index ffe8195fa9..dcb201827f 100644 --- a/deal.II/lac/include/lac/swappable_vector.h +++ b/deal.II/lac/include/lac/swappable_vector.h @@ -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 (@ @) + * @ref Instantiations : some (@ @) * @author Wolfgang Bangerth, 1999, 2000 */ template diff --git a/deal.II/lac/include/lac/tridiagonal_matrix.h b/deal.II/lac/include/lac/tridiagonal_matrix.h index 43a92d4ca8..0ff4bb58cb 100644 --- a/deal.II/lac/include/lac/tridiagonal_matrix.h +++ b/deal.II/lac/include/lac/tridiagonal_matrix.h @@ -338,7 +338,7 @@ class TridiagonalMatrix }; //--------------------------------------------------------------------------- -///@if NoDoc +#ifndef DOXYGEN template unsigned int @@ -399,7 +399,7 @@ TridiagonalMatrix::operator()(unsigned int i, unsigned int j) } -///@endif +#endif // DOXYGEN #endif diff --git a/deal.II/lac/include/lac/vector.h b/deal.II/lac/include/lac/vector.h index e0c112a553..630017866f 100644 --- a/deal.II/lac/include/lac/vector.h +++ b/deal.II/lac/include/lac/vector.h @@ -48,7 +48,7 @@ template class LAPACKFullMatrix; * @p vector (with a lowercase "v"), this class implements an element * of a vector space suitable for numerical computations. * - * @ref Instantiations: some (@ @) + * @ref Instantiations : some (@ @) * @author Guido Kanschat, Franz-Theo Suttmeier, Wolfgang Bangerth */ template diff --git a/deal.II/lac/include/lac/vector_memory.h b/deal.II/lac/include/lac/vector_memory.h index 4fef26effb..acc515870a 100644 --- a/deal.II/lac/include/lac/vector_memory.h +++ b/deal.II/lac/include/lac/vector_memory.h @@ -194,7 +194,7 @@ class GrowingVectorMemory : public VectorMemory /*@}*/ -/// @if NoDoc +#ifndef DOXYGEN /* --------------------- inline functions ---------------------- */ @@ -304,6 +304,6 @@ GrowingVectorMemory::memory_consumption () const return result; } -///@endif +#endif // DOXYGEN #endif