]> https://gitweb.dealii.org/ - dealii.git/commitdiff
doc: no doxygen for friend declarations 8409/head
authorTimo Heister <timo.heister@gmail.com>
Wed, 24 Jul 2019 01:47:37 +0000 (21:47 -0400)
committerTimo Heister <timo.heister@gmail.com>
Wed, 24 Jul 2019 01:47:37 +0000 (21:47 -0400)
It doesn't make sense to use doxygen format for friend declarations.
Even worse, it sometimes stops the correct documentation from showing
up.

As a bonus, this PR also has some hidden other fixes found while
replacing the comments.

50 files changed:
include/deal.II/base/process_grid.h
include/deal.II/base/table.h
include/deal.II/base/vectorization.h
include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_objects.h
include/deal.II/fe/fe_abf.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_dgq.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/mapping.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/grid/tria_iterator.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/dof_level.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/filtered_matrix.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/la_vector.h
include/deal.II/lac/matrix_iterator.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/slepc_spectral_transformation.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/particles/particle_accessor.h

index 0673c6d44bcb50403e771c7d090fef2e304c25ab..5c733beda24f8e600f805afeb74c5da6318e8130 100644 (file)
@@ -62,9 +62,7 @@ namespace Utilities
     class ProcessGrid
     {
     public:
-      /**
-       * Declare class ScaLAPACK as friend to provide access to private members.
-       */
+      // Declare class ScaLAPACK as friend to provide access to private members.
       template <typename NumberType>
       friend class dealii::ScaLAPACKMatrix;
 
index b2c794b91da6911c921c98eb557170ecb4860556..2e6024756205f3cbe5c89bafd9aea9260cb868b3 100644 (file)
@@ -674,9 +674,7 @@ protected:
    */
   TableIndices<N> table_size;
 
-  /**
-   * Make all other table classes friends.
-   */
+  // Make all other table classes friends.
   template <int, typename>
   friend class TableBase;
 };
@@ -955,14 +953,10 @@ namespace MatrixTableIterators
     void
     assert_valid_linear_index() const;
 
-    /**
-     * Make the const version a friend for copying.
-     */
+    // Make the const version a friend for copying.
     friend class AccessorBase<TableType, true, storage_order>;
 
-    /**
-     * Make the underlying iterator class a friend.
-     */
+    // Make the underlying iterator class a friend.
     friend class LinearIndexIterator<
       Iterator<TableType, Constness, storage_order>,
       Accessor<TableType, Constness, storage_order>>;
@@ -1352,19 +1346,15 @@ protected:
   typename AlignedVector<T>::const_reference
   el(const size_type i, const size_type j) const;
 
-  /**
-   * Make the AccessorBase class a friend so that it may directly index into
-   * the array.
-   */
+  // Make the AccessorBase class a friend so that it may directly index into
+  // the array.
   friend class MatrixTableIterators::
     AccessorBase<Table<2, T>, true, MatrixTableIterators::Storage::row_major>;
   friend class MatrixTableIterators::
     AccessorBase<Table<2, T>, false, MatrixTableIterators::Storage::row_major>;
 
-  /**
-   * Make the mutable accessor class a friend so that we can write to array
-   * entries with iterators.
-   */
+  // Make the mutable accessor class a friend so that we can write to array
+  // entries with iterators.
   friend class MatrixTableIterators::
     Accessor<Table<2, T>, false, MatrixTableIterators::Storage::row_major>;
 };
@@ -2084,10 +2074,8 @@ protected:
   const_reference
   el(const size_type i, const size_type j) const;
 
-  /**
-   * Make the AccessorBase class a friend so that it may directly index into
-   * the array.
-   */
+  // Make the AccessorBase class a friend so that it may directly index into
+  // the array.
   friend class MatrixTableIterators::AccessorBase<
     TransposeTable<T>,
     true,
@@ -2097,10 +2085,8 @@ protected:
     false,
     MatrixTableIterators::Storage::column_major>;
 
-  /**
-   * Make the mutable accessor class a friend so that we can write to array
-   * entries with iterators.
-   */
+  // Make the mutable accessor class a friend so that we can write to array
+  // entries with iterators.
   friend class MatrixTableIterators::Accessor<
     TransposeTable<T>,
     false,
index 26c4fdd1172172b67a2b423974fef1d53904f09f..6148838b36e6df8dc72c32579fd9fb78c5bf7388 100644 (file)
@@ -475,9 +475,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -900,9 +898,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -1321,9 +1317,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -1784,9 +1778,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -2174,9 +2166,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -2571,9 +2561,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -2920,9 +2908,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -3243,9 +3229,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
@@ -3463,9 +3447,7 @@ private:
     return res;
   }
 
-  /**
-   * Make a few functions friends.
-   */
+  // Make a few functions friends.
   template <typename Number2, int width2>
   friend VectorizedArray<Number2, width2>
   std::sqrt(const VectorizedArray<Number2, width2> &);
index f6e424f38db44983a6c69bfb4e355c711e6270eb..11ef17819cd9b859c61639d199c44460ffbf21e0 100644 (file)
@@ -729,20 +729,16 @@ protected:
     const types::global_dof_index index,
     const unsigned int fe_index = DoFHandlerType::default_fe_index) const;
 
-  /**
-   * Iterator classes need to be friends because they need to access
-   * operator== and operator!=.
-   */
+  // Iterator classes need to be friends because they need to access
+  // operator== and operator!=.
   template <typename>
   friend class TriaRawIterator;
   template <int, class, bool>
   friend class DoFAccessor;
 
 private:
-  /**
-   * Make the DoFHandler class a friend so that it can call the set_xxx()
-   * functions.
-   */
+  // Make the DoFHandler class a friend so that it can call the set_xxx()
+  // functions.
   template <int dim, int spacedim>
   friend class DoFHandler;
   template <int dim, int spacedim>
@@ -1206,18 +1202,14 @@ protected:
     const types::global_dof_index index,
     const unsigned int fe_index = AccessorData::default_fe_index) const;
 
-  /**
-   * Iterator classes need to be friends because they need to access
-   * operator== and operator!=.
-   */
+  // Iterator classes need to be friends because they need to access
+  // operator== and operator!=.
   template <typename>
   friend class TriaRawIterator;
 
 
-  /**
-   * Make the DoFHandler class a friend so that it can call the set_xxx()
-   * functions.
-   */
+  // Make the DoFHandler class a friend so that it can call the set_xxx()
+  // functions.
   template <int, int>
   friend class DoFHandler;
   template <int, int>
@@ -2008,10 +2000,8 @@ public:
    */
 
 private:
-  /**
-   * Make the DoFHandler class a friend so that it can call the
-   * update_cell_dof_indices_cache() function
-   */
+  // Make the DoFHandler class a friend so that it can call the
+  // update_cell_dof_indices_cache() function
   template <int dim, int spacedim>
   friend class DoFHandler;
   friend struct dealii::internal::DoFCellAccessorImplementation::Implementation;
index 3b2502ef59e4965221d7257b74abec153f224d01..589afdb1926a34e61c129a70131b7bc7ed9d3b60 100644 (file)
@@ -1418,9 +1418,7 @@ private:
   std::unique_ptr<dealii::internal::DoFHandlerImplementation::DoFFaces<dim>>
     mg_faces;
 
-  /**
-   * Make accessor objects friends.
-   */
+  // Make accessor objects friends.
   template <int, class, bool>
   friend class DoFAccessor;
   template <class, bool>
index 1811d930df0e262320ed0394e522272cb29d30a2..b776d384887f5616c6a857892029b97df0eb0122 100644 (file)
@@ -149,10 +149,8 @@ namespace internal
       void
       serialize(Archive &ar, const unsigned int version);
 
-      /**
-       * Declare the classes that store levels and faces of DoFs friends so
-       * that they can resize arrays.
-       */
+      // Declare the classes that store levels and faces of DoFs friends so
+      // that they can resize arrays.
       template <int>
       friend class DoFLevel;
       template <int>
index 30012bc51dfcceae76785d6fedc774864a92c31f..25c1fae511ab59541db61bd347ac923308bbfb28 100644 (file)
@@ -244,9 +244,7 @@ private:
   Table<3, double> interior_weights_abf;
 
 
-  /**
-   * Allow access from other dimensions.
-   */
+  // Allow access from other dimensions.
   template <int dim1>
   friend class FE_ABF;
 };
index 80a565427150689b827181602cee18218263a697..57a4007dd2274517fd66fe123ceebcc19922b42d 100644 (file)
@@ -579,9 +579,7 @@ private:
    */
   const PolynomialSpace<dim> polynomial_space;
 
-  /**
-   * Allow access from other dimensions.
-   */
+  // Allow access from other dimensions.
   template <int, int>
   friend class FE_DGPNonparametric;
 };
index de3c6975099b9e8c836039049e9d0d8ec0a9767d..c4fc6ffa61a6c36f15bb9b4c7b7f85ef6e3d21a3 100644 (file)
@@ -377,15 +377,11 @@ private:
    */
   mutable Threads::Mutex mutex;
 
-  /**
-   * Allow access from other dimensions.
-   */
+  // Allow access from other dimensions.
   template <int dim1, int spacedim1>
   friend class FE_DGQ;
 
-  /**
-   * Allow @p MappingQ class to access to build_renumbering function.
-   */
+  // Allow @p MappingQ class to access to build_renumbering function.
   template <int dim1, int spacedim1>
   friend class MappingQ;
 };
index 0256343594eb6a2e57587209ec819821073ea387..93c1541f5c72efcf19dd4f67a3c132b1e86d600d 100644 (file)
@@ -323,14 +323,12 @@ private:
    */
   Table<2, double> boundary_weights;
 
-  /*
+  /**
    * Mutex for protecting initialization of restriction and embedding matrix.
    */
   mutable Threads::Mutex mutex;
 
-  /**
-   * Allow access from other dimensions.
-   */
+  // Allow access from other dimensions.
   template <int dim1>
   friend class FE_Nedelec;
 };
index 39e9c3282d1a60dae93650e0c7c371399979ad48..5828c6e970e45678621d047486510d1c95384dd9 100644 (file)
@@ -330,18 +330,16 @@ protected:
    */
   struct Implementation;
 
-  /*
-   * Declare implementation friend.
-   */
+  // Declare implementation friend.
   friend struct FE_Q_Base<PolynomialType, dim, spacedim>::Implementation;
 
 private:
-  /*
+  /**
    * Mutex for protecting initialization of restriction and embedding matrix.
    */
   mutable Threads::Mutex mutex;
 
-  /*
+  /**
    * The highest polynomial degree of the underlying tensor product space
    * without any enrichment. For FE_Q*(p) this is p. Note that enrichments
    * may lead to a difference to degree.
index f9b6d7e04f7d5357f32208abc1793faf43f3bd7d..250e98bb5959ae6a73fbd38d3a76467c2fd89d5d 100644 (file)
@@ -785,12 +785,10 @@ private:
    */
   const std::vector<unsigned int> face_renumber;
 
-  /**
-   * Allow access from other dimensions. We need this since we want to call
-   * the functions @p get_dpo_vector and @p
-   * lexicographic_to_hierarchic_numbering for the faces of the finite element
-   * of dimension dim+1.
-   */
+  // Allow access from other dimensions. We need this since we want to call
+  // the functions @p get_dpo_vector and @p
+  // lexicographic_to_hierarchic_numbering for the faces of the finite element
+  // of dimension dim+1.
   template <int dim1>
   friend class FE_Q_Hierarchical;
 };
index af43eafd1641efdaf865393ea3666cd007f770c9..dd4c284a6804f7a6b35aa20d8321b7ec1cabb7ae 100644 (file)
@@ -197,9 +197,7 @@ private:
    */
   Table<3, double> interior_weights;
 
-  /**
-   * Allow access from other dimensions.
-   */
+  // Allow access from other dimensions.
   template <int dim1>
   friend class FE_RaviartThomas;
 };
index 06c3cc1f5cbe589ff2e34fe6f159d08770351815..9b59fba0a52014752be91d08772076012078e905 100644 (file)
@@ -1226,7 +1226,7 @@ private:
       base_fe_output_objects;
   };
 
-  /*
+  /**
    * Mutex for protecting initialization of restriction and embedding matrix.
    */
   mutable Threads::Mutex mutex;
index f9b02c014d26b17786e97c42e2ad57301bc91d85..4a372f0e29e479b42fc392a7bdf3d13555dca2ae 100644 (file)
@@ -3468,10 +3468,8 @@ private:
    */
   dealii::internal::FEValuesViews::Cache<dim, spacedim> fe_values_views_cache;
 
-  /**
-   * Make the view classes friends of this class, since they access internal
-   * data.
-   */
+  // Make the view classes friends of this class, since they access internal
+  // data.
   template <int, int>
   friend class FEValuesViews::Scalar;
   template <int, int>
index e65879417fdcabc204984c265ef413a26fc8d58f..2025514d2a4fddb44f78ca7d69eff244fe909a06 100644 (file)
@@ -1233,10 +1233,8 @@ public:
    */
 
 
-  /**
-   * Give class @p FEValues access to the private <tt>get_...data</tt> and
-   * <tt>fill_fe_...values</tt> functions.
-   */
+  // Give class @p FEValues access to the private <tt>get_...data</tt> and
+  // <tt>fill_fe_...values</tt> functions.
   friend class FEValuesBase<dim, spacedim>;
   friend class FEValues<dim, spacedim>;
   friend class FEFaceValues<dim, spacedim>;
index ef7cd3c6bc292208ebf62615f91b97d60fb3fb12..ccafa3a204a6e647018f9cd6673d68c505cfb51b 100644 (file)
@@ -618,9 +618,7 @@ private:
                     InternalData &         data) const;
 
 
-  /**
-   * Declare other MappingFEField classes friends.
-   */
+  // Declare other MappingFEField classes friends.
   template <int, int, class, class>
   friend class MappingFEField;
 };
index 5b1f2f8409597102eec25aab1419edebea50e0c8..8932a2db54c4ac9c3a2efa64d392a9a722c1f38d 100644 (file)
@@ -732,17 +732,13 @@ protected:
     const typename Triangulation<dim, spacedim>::cell_iterator &cell,
     std::vector<Point<spacedim>> &                              a) const;
 
-  /**
-   * Make MappingQ a friend since it needs to call the fill_fe_values()
-   * functions on its MappingQGeneric(1) sub-object.
-   */
+  // Make MappingQ a friend since it needs to call the fill_fe_values()
+  // functions on its MappingQGeneric(1) sub-object.
   template <int, int>
   friend class MappingQ;
 
-  /**
-   * Make MappingQCache a friend since it needs to call the
-   * compute_mapping_support_points() function.
-   */
+  // Make MappingQCache a friend since it needs to call the
+  // compute_mapping_support_points() function.
   template <int, int>
   friend class MappingQCache;
 };
index a37be90aa67f5c9267ab665180ac803b76c4d389..87dcb3688a0d82c274268009973209074726c11f 100644 (file)
@@ -548,15 +548,13 @@ protected:
   Accessor accessor;
 
 
-  /**
-   * Make all other iterator class templates friends of this class. This is
-   * necessary for the implementation of conversion constructors.
-   *
-   * In fact, we would not need them to be friends if they were for different
-   * dimensions, but the compiler dislikes giving a fixed dimension and
-   * variable accessor since then it says that would be a partial
-   * specialization.
-   */
+  // Make all other iterator class templates friends of this class. This is
+  // necessary for the implementation of conversion constructors.
+  //
+  // In fact, we would not need them to be friends if they were for different
+  // dimensions, but the compiler dislikes giving a fixed dimension and
+  // variable accessor since then it says that would be a partial
+  // specialization.
   template <typename SomeAccessor>
   friend class TriaRawIterator;
   template <typename SomeAccessor>
index abb18fdbbcaa92e2cb5032a6d3195adb1091100b..a1b07aeb74da9f234005c2c7f8a5d2ed8aee511b 100644 (file)
@@ -1355,9 +1355,7 @@ namespace hp
      */
     std::vector<boost::signals2::connection> tria_listeners;
 
-    /**
-     * Make accessor objects friends.
-     */
+    // Make accessor objects friends.
     template <int, class, bool>
     friend class dealii::DoFAccessor;
     template <class, bool>
@@ -1366,10 +1364,8 @@ namespace hp
     friend struct dealii::internal::DoFCellAccessorImplementation::
       Implementation;
 
-    /**
-     * Likewise for DoFLevel objects since they need to access the vertex dofs
-     * in the functions that set and retrieve vertex dof indices.
-     */
+    // Likewise for DoFLevel objects since they need to access the vertex dofs
+    // in the functions that set and retrieve vertex dof indices.
     template <int>
     friend class dealii::internal::hp::DoFIndicesOnFacesOrEdges;
     friend struct dealii::internal::hp::DoFHandlerImplementation::
index f8f1d93485b0dacb568f8146a6ba0005d56eb90f..0af0ffedeae5fddf7eac7cc66374ed5f908c1719 100644 (file)
@@ -365,10 +365,8 @@ namespace internal
       normalize_active_fe_indices();
 
 
-      /**
-       * Make hp::DoFHandler and its auxiliary class a friend since it is the
-       * class that needs to create these data structures.
-       */
+      // Make hp::DoFHandler and its auxiliary class a friend since it is the
+      // class that needs to create these data structures.
       template <int, int>
       friend class dealii::hp::DoFHandler;
       friend struct dealii::internal::hp::DoFHandlerImplementation::
index c39fa54447900f1b6ef06787e796f68040c86560..daee645f62f084fc81e8dc5415c70914adbba401 100644 (file)
@@ -99,9 +99,7 @@ namespace BlockMatrixIterators
      */
     unsigned int col_block;
 
-    /**
-     * Let the iterator class be a friend.
-     */
+    // Let the iterator class be a friend.
     template <typename>
     friend class MatrixIterator;
   };
@@ -280,9 +278,7 @@ namespace BlockMatrixIterators
     bool
     operator==(const Accessor &a) const;
 
-    /**
-     * Let the iterator class be a friend.
-     */
+    // Let the iterator class be a friend.
     template <typename>
     friend class dealii::MatrixIterator;
   };
@@ -1060,10 +1056,8 @@ private:
    */
   TemporaryData temporary_data;
 
-  /**
-   * Make the iterator class a friend. We have to work around a compiler bug
-   * here again.
-   */
+  // Make the iterator class a friend. We have to work around a compiler bug
+  // here again.
   template <typename, bool>
   friend class BlockMatrixIterators::Accessor;
 
index ae3e7d4c9136df800c10a04e15acb698407aafd0..0f3c66c75b52d79baab38c2e4c445db004b480b5 100644 (file)
@@ -377,10 +377,8 @@ private:
    */
   std::vector<std::vector<size_type>> block_column_indices;
 
-  /**
-   * Make the block sparse matrix a friend, so that it can use our
-   * #row_indices and #column_indices objects.
-   */
+  // Make the block sparse matrix a friend, so that it can use our
+  // #row_indices and #column_indices objects.
   template <typename number>
   friend class BlockSparseMatrix;
 };
index c037c056146af1fd3ec1d74db275adac02e0b9ec..047fd2115c9b038c4474d214e37ab2cbb2471ff2 100644 (file)
@@ -398,10 +398,7 @@ namespace internal
       void
       move_backward();
 
-
-      /**
-       * Mark all other instances of this template as friends.
-       */
+      // Mark all other instances of this template as friends.
       template <typename, bool>
       friend class Iterator;
     };
@@ -971,9 +968,7 @@ protected:
    */
   BlockIndices block_indices;
 
-  /**
-   * Make the iterator class a friend.
-   */
+  // Make the iterator class a friend.
   template <typename N, bool C>
   friend class dealii::internal::BlockVectorIterators::Iterator;
 
index 96c2b26720d68b47ef75c82568025cd8457da61b..7a61c84215f5a586042fb649d5d4820dbad2d286 100644 (file)
@@ -141,9 +141,7 @@ namespace ChunkSparseMatrixIterators
      */
     using ChunkSparsityPatternIterators::Accessor::advance;
 
-    /**
-     * Make iterator class a friend.
-     */
+    // Make iterator class a friend.
     template <typename, bool>
     friend class Iterator;
   };
@@ -274,9 +272,7 @@ namespace ChunkSparseMatrixIterators
      */
     using ChunkSparsityPatternIterators::Accessor::advance;
 
-    /**
-     * Make iterator class a friend.
-     */
+    // Make iterator class a friend.
     template <typename, bool>
     friend class Iterator;
   };
@@ -1409,9 +1405,7 @@ private:
   template <typename somenumber>
   friend class ChunkSparseMatrix;
 
-  /**
-   * Also give access to internal details to the iterator/accessor classes.
-   */
+  // Also give access to internal details to the iterator/accessor classes.
   template <typename, bool>
   friend class ChunkSparseMatrixIterators::Iterator;
   template <typename, bool>
index e2399cc4e4c09085d6e39e1eed84ad4f37377644..85f4dfa42aa2aacdd2718be14c297f9f5d824d85 100644 (file)
@@ -155,9 +155,7 @@ namespace ChunkSparsityPatternIterators
     void
     advance();
 
-    /**
-     * Grant access to iterator class.
-     */
+    // Grant access to iterator class.
     friend class Iterator;
   };
 
@@ -852,15 +850,11 @@ private:
    */
   SparsityPattern sparsity_pattern;
 
-  /**
-   * Make all the chunk sparse matrix kinds friends.
-   */
+  // Make all the chunk sparse matrix kinds friends.
   template <typename>
   friend class ChunkSparseMatrix;
 
-  /**
-   * Make the accessor class a friend.
-   */
+  // Make the accessor class a friend.
   friend class ChunkSparsityPatternIterators::Accessor;
 };
 
index 120b14701a9ac1c4b5ae27a23eb8429c38981def..2ad9bc675c86995570a3c82939fefdbe3adde4ad 100644 (file)
@@ -155,9 +155,7 @@ namespace DynamicSparsityPatternIterators
     void
     advance();
 
-    /**
-     * Grant access to iterator class.
-     */
+    // Grant access to iterator class.
     friend class Iterator;
   };
 
index 7c190e828f942d00867128247b7e0fe312d91397..20982e4f95b2bcd195f70889d34ddfecfa557068 100644 (file)
@@ -252,10 +252,8 @@ public:
      * Current row number.
      */
     size_type index;
-    /*
-     * Make enclosing class a
-     * friend.
-     */
+
+    // Make enclosing class a friend.
     friend class const_iterator;
   };
 
@@ -563,9 +561,7 @@ private:
   post_filter(const VectorType &in, VectorType &out) const;
 
   friend class Accessor;
-  /**
-   * FilteredMatrixBlock accesses pre_filter() and post_filter().
-   */
+  // FilteredMatrixBlock accesses pre_filter() and post_filter().
   friend class FilteredMatrixBlock<VectorType>;
 };
 
index b8a1f0a8ef27704d1444d81b5daddb5df40da8ce..c2bef479162c3f153fac90e1f3874925ce0ed85b 100644 (file)
@@ -1385,15 +1385,11 @@ namespace LinearAlgebra
       void
       resize_val(const size_type new_allocated_size);
 
-      /*
-       * Make all other vector types friends.
-       */
+      // Make all other vector types friends.
       template <typename Number2, typename MemorySpace2>
       friend class Vector;
 
-      /**
-       * Make BlockVector type friends.
-       */
+      // Make BlockVector type friends.
       template <typename Number2>
       friend class BlockVector;
     };
index a4e8da0a5c8570ddc3c96e0d7583415dbc8e0512..66e8f57e82d81a1cd9e9dd86f23f3e9bec65bcf6 100644 (file)
@@ -411,9 +411,7 @@ namespace LinearAlgebra
 
     friend class boost::serialization::access;
 
-    /**
-     * Make all other ReadWriteVector types friends.
-     */
+    // Make all other ReadWriteVector types friends.
     template <typename Number2>
     friend class Vector;
   };
index 636546f9eb462f9f263393bdb621945c0912f890..1b43503f0be79a7365feeceade74d400255bd128 100644 (file)
@@ -118,9 +118,7 @@ private:
    */
   ACCESSOR accessor;
 
-  /**
-   * Allow other iterators access to private data.
-   */
+  // Allow other iterators access to private data.
   template <class OtherAccessor>
   friend class MatrixIterator;
 };
index bc1010a9018b6614d241a2dbbed0f192c9d021b5..1b8bbc48e0c8a12070251eed8d6da3eaf1afc65d 100644 (file)
@@ -167,9 +167,7 @@ namespace PETScWrappers
         void
         visit_present_row();
 
-        /**
-         * Make enclosing class a friend.
-         */
+        // Make enclosing class a friend.
         friend class const_iterator;
       };
 
@@ -1068,9 +1066,7 @@ namespace PETScWrappers
     mutable std::vector<PetscScalar> column_values;
 
 
-    /**
-     * To allow calling protected prepare_add() and prepare_set().
-     */
+    // To allow calling protected prepare_add() and prepare_set().
     template <class>
     friend class dealii::BlockMatrixBase;
   };
index 713105d8116d725463c384a23eddef4d05cf2184..233d54795588f319448dfb70751776726e890e4b 100644 (file)
@@ -111,10 +111,8 @@ namespace PETScWrappers
      */
     operator Mat() const;
 
-    /**
-     * Make the solver class a friend, since it needs to call the conversion
-     * operator.
-     */
+    // Make the solver class a friend, since it needs to call the conversion
+    // operator.
     friend class SolverBase;
   };
 
index a71660e0ec81e93d93411e1c4b7ad46c9faf0e02..3bca1ed1af98562db09ae851cdf0855cb31db8f4 100644 (file)
@@ -247,10 +247,8 @@ namespace PETScWrappers
     std::unique_ptr<SolverData> solver_data;
 
 #    ifdef DEAL_II_WITH_SLEPC
-    /**
-     * Make the transformation class a friend, since it needs to set the KSP
-     * solver.
-     */
+    // Make the transformation class a friend, since it needs to set the KSP
+    // solver.
     friend class SLEPcWrappers::TransformationBase;
 #    endif
   };
index 631f23d70bbdb75f5c00391a1468af950fec7211..9760474f4e7b5d6e52b90eb444bbc0edd9df5517 100644 (file)
@@ -280,9 +280,7 @@ namespace PETScWrappers
     do_reinit(const SparsityPatternType &sparsity_pattern,
               const bool                 preset_nonzero_locations);
 
-    /**
-     * To allow calling protected prepare_add() and prepare_set().
-     */
+    // To allow calling protected prepare_add() and prepare_set().
     friend class BlockMatrixBase<SparseMatrix>;
   };
 
@@ -756,9 +754,7 @@ namespace PETScWrappers
                 const IndexSet &           local_columns,
                 const SparsityPatternType &sparsity_pattern);
 
-      /**
-       * To allow calling protected prepare_add() and prepare_set().
-       */
+      // To allow calling protected prepare_add() and prepare_set().
       friend class BlockMatrixBase<SparseMatrix>;
     };
 
index 8eb3d04f6069ccdcafb1827fd3b67bca0f25d8b9..5316ecd0cf7fc752583c24f95acd19ee14c12484 100644 (file)
@@ -198,10 +198,8 @@ namespace PETScWrappers
        */
       const size_type index;
 
-      /**
-       * Make the vector class a friend, so that it can create objects of the
-       * present type.
-       */
+      // Make the vector class a friend, so that it can create objects of the
+      // present type.
       friend class ::dealii::PETScWrappers::VectorBase;
     };
   } // namespace internal
@@ -791,9 +789,7 @@ namespace PETScWrappers
      */
     mutable VectorOperation::values last_action;
 
-    /**
-     * Make the reference class a friend.
-     */
+    // Make the reference class a friend.
     friend class internal::VectorReference;
 
     /**
index 4ac093e7ed5117f5e1d95c8b9706808d11789613..4971b9469b20bf3f5c40f73c80f2a9d33caa34d5 100644 (file)
@@ -458,9 +458,7 @@ public:
        */
       typename FullMatrix<inverse_type>::const_iterator b_end;
 
-      /**
-       * Make enclosing class a friend.
-       */
+      // Make enclosing class a friend.
       friend class const_iterator;
     };
 
index 434b2e348a65317940bdaaf4612fde6eea6f1ebf..0b2ee464591e823c8af00dd1eeafab330e4a2b4e 100644 (file)
@@ -707,9 +707,7 @@ namespace LinearAlgebra
     mutable std::shared_ptr<::dealii::parallel::internal::TBBPartitioner>
       thread_loop_partitioner;
 
-    /**
-     * Make all other ReadWriteVector types friends.
-     */
+    // Make all other ReadWriteVector types friends.
     template <typename Number2>
     friend class ReadWriteVector;
 
index 1b53f1235a321b20848250311f42c5c9055e537d..7763471664fc683cae851066b996ab7527791df0 100644 (file)
@@ -106,10 +106,8 @@ namespace SLEPcWrappers
      */
     ST st;
 
-    /**
-     * Make the solver class a friend, since it needs to set spectral
-     * transformation object.
-     */
+    // Make the solver class a friend, since it needs to set spectral
+    // transformation object.
     friend class SolverBase;
   };
 
@@ -192,10 +190,8 @@ namespace SLEPcWrappers
      */
     const AdditionalData additional_data;
 
-    /**
-     * Make the solver class a friend, since it may need to set target
-     * equal the provided shift value.
-     */
+    // Make the solver class a friend, since it may need to set target
+    // equal the provided shift value.
     friend class SolverBase;
   };
 
index e1797cd7bbb271ecac2f4d040166422adcdfcba6..d67f21539804216712c88bdefdabf2b3e6c89828 100644 (file)
@@ -173,9 +173,7 @@ namespace SparseMatrixIterators
      */
     using SparsityPatternIterators::Accessor::advance;
 
-    /**
-     * Make iterator class a friend.
-     */
+    // Make iterator class a friend.
     template <typename, bool>
     friend class Iterator;
   };
@@ -308,9 +306,7 @@ namespace SparseMatrixIterators
      */
     using SparsityPatternIterators::Accessor::advance;
 
-    /**
-     * Make iterator class a friend.
-     */
+    // Make iterator class a friend.
     template <typename, bool>
     friend class Iterator;
   };
@@ -1733,24 +1729,18 @@ private:
   template <typename>
   friend class SparseILU;
 
-  /**
-   * To allow it calling private prepare_add() and prepare_set().
-   */
+  // To allow it calling private prepare_add() and prepare_set().
   template <typename>
   friend class BlockMatrixBase;
 
-  /**
-   * Also give access to internal details to the iterator/accessor classes.
-   */
+  // Also give access to internal details to the iterator/accessor classes.
   template <typename, bool>
   friend class SparseMatrixIterators::Iterator;
   template <typename, bool>
   friend class SparseMatrixIterators::Accessor;
 
 #  ifdef DEAL_II_WITH_MPI
-  /**
-   * Give access to internal datastructures to perform MPI operations.
-   */
+  // Give access to internal datastructures to perform MPI operations.
   template <typename Number>
   friend void
   Utilities::MPI::sum(const SparseMatrix<Number> &,
index a9d248ddd4852f0d636979d38c29bfcf04616145..89a86beb5ada154051b57e16f6f7504e59381b90 100644 (file)
@@ -232,9 +232,7 @@ public:
        */
       unsigned short a_index;
 
-      /**
-       * Make enclosing class a friend.
-       */
+      // Make enclosing class a friend.
       friend class const_iterator;
     };
 
@@ -285,14 +283,6 @@ public:
      * Store an object of the accessor class.
      */
     Accessor accessor;
-
-    /**
-     * Make the enclosing class a friend. This is only necessary since icc7
-     * otherwise wouldn't allow us to make const_iterator::Accessor a friend,
-     * stating that it can't access this class -- this is of course bogus,
-     * since granting friendship doesn't need access to the class being
-     * granted friendship...
-     */
   };
 
   /**
index 46961cf637749e0e0dc6ec4df3906c2df1b11062..0b6c4cc14108cc4052754e51ec8d71c973ffab05 100644 (file)
@@ -365,18 +365,16 @@ private:
   void
   compute_inverse(const size_type row, std::vector<size_type> &local_indices);
 
-  /**
-   * Make the derived class a friend. This seems silly, but is actually
-   * necessary, since derived classes can only access non-public members
-   * through their @p this pointer, but not access these members as member
-   * functions of other objects of the type of this base class (i.e. like
-   * <tt>x.f()</tt>, where @p x is an object of the base class, and @p f one
-   * of it's non-public member functions).
-   *
-   * Now, in the case of the @p SparseBlockVanka class, we would like to take
-   * the address of a function of the base class in order to call it through
-   * the multithreading framework, so the derived class has to be a friend.
-   */
+  // Make the derived class a friend. This seems silly, but is actually
+  // necessary, since derived classes can only access non-public members
+  // through their @p this pointer, but not access these members as member
+  // functions of other objects of the type of this base class (i.e. like
+  // <tt>x.f()</tt>, where @p x is an object of the base class, and @p f one
+  // of it's non-public member functions).
+  //
+  // Now, in the case of the @p SparseBlockVanka class, we would like to take
+  // the address of a function of the base class in order to call it through
+  // the multithreading framework, so the derived class has to be a friend.
   template <typename T>
   friend class SparseBlockVanka;
 };
index b3ddd84ee3fe4f53545a3b5e7d61b539ba5ebdd3..4b73b116a2fdb469d6c768a4a373dabb43a00080 100644 (file)
@@ -243,14 +243,10 @@ namespace SparsityPatternIterators
     void
     advance();
 
-    /**
-     * Grant access to iterator class.
-     */
+    // Grant access to iterator class.
     friend class LinearIndexIterator<Iterator, Accessor>;
 
-    /**
-     * Grant access to accessor class of ChunkSparsityPattern.
-     */
+    // Grant access to accessor class of ChunkSparsityPattern.
     friend class ChunkSparsityPatternIterators::Accessor;
   };
 
@@ -803,9 +799,7 @@ protected:
    */
   bool compressed;
 
-  /**
-   * Make all sparse matrices friends of this class.
-   */
+  // Make all sparse matrices friends of this class.
   template <typename number>
   friend class SparseMatrix;
   template <typename number>
@@ -818,9 +812,7 @@ protected:
   friend class ChunkSparsityPattern;
   friend class DynamicSparsityPattern;
 
-  /**
-   * Also give access to internal details to the iterator/accessor classes.
-   */
+  // Also give access to internal details to the iterator/accessor classes.
   friend class SparsityPatternIterators::Iterator;
   friend class SparsityPatternIterators::Accessor;
   friend class ChunkSparsityPatternIterators::Accessor;
@@ -1293,9 +1285,7 @@ private:
    */
   bool store_diagonal_first_in_row;
 
-  /**
-   * Make all sparse matrices friends of this class.
-   */
+  // Make all sparse matrices friends of this class.
   template <typename number>
   friend class SparseMatrix;
   template <typename number>
@@ -1308,9 +1298,7 @@ private:
   friend class ChunkSparsityPattern;
   friend class DynamicSparsityPattern;
 
-  /**
-   * Also give access to internal details to the iterator/accessor classes.
-   */
+  // Also give access to internal details to the iterator/accessor classes.
   friend class SparsityPatternIterators::Iterator;
   friend class SparsityPatternIterators::Accessor;
   friend class ChunkSparsityPatternIterators::Accessor;
index 33732d99ce5ece30cdb119155d90191d6b09f3a9..13b4181ad751a184462a1a8a16ab2edf8cd1d05f 100644 (file)
@@ -245,9 +245,7 @@ namespace TrilinosWrappers
       value() const;
 
     private:
-      /**
-       * Make iterator class a friend.
-       */
+      // Make iterator class a friend.
       template <bool>
       friend class Iterator;
     };
@@ -329,14 +327,11 @@ namespace TrilinosWrappers
       value() const;
 
     private:
-      /**
-       * Make iterator class a friend.
-       */
+      // Make iterator class a friend.
       template <bool>
       friend class Iterator;
-      /**
-       * Make Reference object a friend.
-       */
+
+      // Make Reference object a friend.
       friend class Reference;
     };
 
@@ -2149,9 +2144,7 @@ namespace TrilinosWrappers
      */
     bool compressed;
 
-    /**
-     * To allow calling protected prepare_add() and prepare_set().
-     */
+    // To allow calling protected prepare_add() and prepare_set().
     friend class BlockMatrixBase<SparseMatrix>;
   };
 
index 820af53d43ad664d6b2106d1170c6800cdd58895..273d0ba4c8c00024b7d818efd127ae340eb6db1f 100644 (file)
@@ -158,9 +158,7 @@ namespace TrilinosWrappers
       void
       visit_present_row();
 
-      /**
-       * Make enclosing class a friend.
-       */
+      // Make enclosing class a friend.
       friend class Iterator;
     };
 
index 2eb90f7c055d6b733738105410cb301ab9316c8b..a4b7c00d38b44f495bb65eeddc64fa5bb470a8a1 100644 (file)
@@ -179,10 +179,8 @@ namespace TrilinosWrappers
        */
       const size_type index;
 
-      /**
-       * Make the vector class a friend, so that it can create objects of the
-       * present type.
-       */
+      // Make the vector class a friend, so that it can create objects of the
+      // present type.
       friend class ::dealii::TrilinosWrappers::MPI::Vector;
     };
   } // namespace internal
@@ -1335,9 +1333,7 @@ namespace TrilinosWrappers
        */
       IndexSet owned_elements;
 
-      /**
-       * Make the reference class a friend.
-       */
+      // Make the reference class a friend.
       friend class internal::VectorReference;
     };
 
index 9d629dcb89dbdd05a75969b31229df1eebc98caa..349729a2bca227b84afc372dcdc0574eab021f97 100644 (file)
@@ -1036,9 +1036,7 @@ private:
   mutable std::shared_ptr<parallel::internal::TBBPartitioner>
     thread_loop_partitioner;
 
-  /**
-   * Make all other vector types friends.
-   */
+  // Make all other vector types friends.
   template <typename Number2>
   friend class Vector;
 };
index 9d91c0d55f67fe848f014b536410ec45ecaa0789..753fb8fc5797484e75979a457ea880e1fd1952e9 100644 (file)
@@ -1125,9 +1125,7 @@ private:
   void
   set_data_pointers();
 
-  /**
-   * Make other FEEvaluationBase as well as FEEvaluation objects friends.
-   */
+  // Make other FEEvaluationBase as well as FEEvaluation objects friends.
   template <int, int, typename, bool, typename>
   friend class FEEvaluationBase;
   template <int, int, int, int, typename, typename>
index b882827e45230e97cafbee203ad8661c453fa701..7d6622dac45c87c6e7f1fe7f775867ba7004dde3 100644 (file)
@@ -992,10 +992,8 @@ protected:
                DataComponentInterpretation::DataComponentInterpretation>>
   get_nonscalar_data_ranges() const override;
 
-  /**
-   * Make all template siblings friends. Needed for the merge_patches()
-   * function.
-   */
+  // Make all template siblings friends. Needed for the merge_patches()
+  // function.
   template <class, int, int>
   friend class DataOut_DoFData;
 
index f7d4b8dfd46c79eb67e7788c36f1e549e04c873b..e773c62ec92db6454b9dcf73a604546658a2197b 100644 (file)
@@ -214,10 +214,8 @@ namespace Particles
     typename std::multimap<internal::LevelInd,
                            Particle<dim, spacedim>>::iterator particle;
 
-    /**
-     * Make ParticleIterator a friend to allow it constructing
-     * ParticleAccessors.
-     */
+    // Make ParticleIterator a friend to allow it constructing
+    // ParticleAccessors.
     template <int, int>
     friend class ParticleIterator;
     template <int, int>

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.