From f8c753ba0999abc07b7cd504f92279b0fc8b00f8 Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Tue, 23 Jul 2019 21:47:37 -0400 Subject: [PATCH] doc: no doxygen for friend declarations 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. --- include/deal.II/base/process_grid.h | 4 +-- include/deal.II/base/table.h | 36 ++++++------------- include/deal.II/base/vectorization.h | 36 +++++-------------- include/deal.II/dofs/dof_accessor.h | 30 ++++++---------- include/deal.II/dofs/dof_handler.h | 4 +-- include/deal.II/dofs/dof_objects.h | 6 ++-- include/deal.II/fe/fe_abf.h | 4 +-- include/deal.II/fe/fe_dgp_nonparametric.h | 4 +-- include/deal.II/fe/fe_dgq.h | 8 ++--- include/deal.II/fe/fe_nedelec.h | 6 ++-- include/deal.II/fe/fe_q_base.h | 8 ++--- include/deal.II/fe/fe_q_hierarchical.h | 10 +++--- include/deal.II/fe/fe_raviart_thomas.h | 4 +-- include/deal.II/fe/fe_system.h | 2 +- include/deal.II/fe/fe_values.h | 6 ++-- include/deal.II/fe/mapping.h | 6 ++-- include/deal.II/fe/mapping_fe_field.h | 4 +-- include/deal.II/fe/mapping_q_generic.h | 12 +++---- include/deal.II/grid/tria_iterator.h | 16 ++++----- include/deal.II/hp/dof_handler.h | 10 ++---- include/deal.II/hp/dof_level.h | 6 ++-- include/deal.II/lac/block_matrix_base.h | 14 +++----- include/deal.II/lac/block_sparsity_pattern.h | 6 ++-- include/deal.II/lac/block_vector_base.h | 9 ++--- include/deal.II/lac/chunk_sparse_matrix.h | 12 ++----- include/deal.II/lac/chunk_sparsity_pattern.h | 12 ++----- .../deal.II/lac/dynamic_sparsity_pattern.h | 4 +-- include/deal.II/lac/filtered_matrix.h | 10 ++---- include/deal.II/lac/la_parallel_vector.h | 8 ++--- include/deal.II/lac/la_vector.h | 4 +-- include/deal.II/lac/matrix_iterator.h | 4 +-- include/deal.II/lac/petsc_matrix_base.h | 8 ++--- include/deal.II/lac/petsc_precondition.h | 6 ++-- include/deal.II/lac/petsc_solver.h | 6 ++-- include/deal.II/lac/petsc_sparse_matrix.h | 8 ++--- include/deal.II/lac/petsc_vector_base.h | 10 ++---- include/deal.II/lac/precondition_block.h | 4 +-- include/deal.II/lac/read_write_vector.h | 4 +-- .../lac/slepc_spectral_transformation.h | 12 +++---- include/deal.II/lac/sparse_matrix.h | 20 +++-------- include/deal.II/lac/sparse_matrix_ez.h | 12 +------ include/deal.II/lac/sparse_vanka.h | 22 ++++++------ include/deal.II/lac/sparsity_pattern.h | 24 ++++--------- include/deal.II/lac/trilinos_sparse_matrix.h | 17 +++------ .../deal.II/lac/trilinos_sparsity_pattern.h | 4 +-- include/deal.II/lac/trilinos_vector.h | 10 ++---- include/deal.II/lac/vector.h | 4 +-- include/deal.II/matrix_free/fe_evaluation.h | 4 +-- include/deal.II/numerics/data_out_dof_data.h | 6 ++-- include/deal.II/particles/particle_accessor.h | 6 ++-- 50 files changed, 146 insertions(+), 346 deletions(-) diff --git a/include/deal.II/base/process_grid.h b/include/deal.II/base/process_grid.h index 0673c6d44b..5c733beda2 100644 --- a/include/deal.II/base/process_grid.h +++ b/include/deal.II/base/process_grid.h @@ -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 friend class dealii::ScaLAPACKMatrix; diff --git a/include/deal.II/base/table.h b/include/deal.II/base/table.h index b2c794b91d..2e60247562 100644 --- a/include/deal.II/base/table.h +++ b/include/deal.II/base/table.h @@ -674,9 +674,7 @@ protected: */ TableIndices table_size; - /** - * Make all other table classes friends. - */ + // Make all other table classes friends. template 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; - /** - * Make the underlying iterator class a friend. - */ + // Make the underlying iterator class a friend. friend class LinearIndexIterator< Iterator, Accessor>; @@ -1352,19 +1346,15 @@ protected: typename AlignedVector::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, true, MatrixTableIterators::Storage::row_major>; friend class MatrixTableIterators:: AccessorBase, 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, 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, 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, false, diff --git a/include/deal.II/base/vectorization.h b/include/deal.II/base/vectorization.h index 26c4fdd117..6148838b36 100644 --- a/include/deal.II/base/vectorization.h +++ b/include/deal.II/base/vectorization.h @@ -475,9 +475,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -900,9 +898,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -1321,9 +1317,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -1784,9 +1778,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -2174,9 +2166,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -2571,9 +2561,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -2920,9 +2908,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -3243,9 +3229,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); @@ -3463,9 +3447,7 @@ private: return res; } - /** - * Make a few functions friends. - */ + // Make a few functions friends. template friend VectorizedArray std::sqrt(const VectorizedArray &); diff --git a/include/deal.II/dofs/dof_accessor.h b/include/deal.II/dofs/dof_accessor.h index f6e424f38d..11ef17819c 100644 --- a/include/deal.II/dofs/dof_accessor.h +++ b/include/deal.II/dofs/dof_accessor.h @@ -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 friend class TriaRawIterator; template 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 friend class DoFHandler; template @@ -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 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 friend class DoFHandler; template @@ -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 friend class DoFHandler; friend struct dealii::internal::DoFCellAccessorImplementation::Implementation; diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index 3b2502ef59..589afdb192 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -1418,9 +1418,7 @@ private: std::unique_ptr> mg_faces; - /** - * Make accessor objects friends. - */ + // Make accessor objects friends. template friend class DoFAccessor; template diff --git a/include/deal.II/dofs/dof_objects.h b/include/deal.II/dofs/dof_objects.h index 1811d930df..b776d38488 100644 --- a/include/deal.II/dofs/dof_objects.h +++ b/include/deal.II/dofs/dof_objects.h @@ -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 friend class DoFLevel; template diff --git a/include/deal.II/fe/fe_abf.h b/include/deal.II/fe/fe_abf.h index 30012bc51d..25c1fae511 100644 --- a/include/deal.II/fe/fe_abf.h +++ b/include/deal.II/fe/fe_abf.h @@ -244,9 +244,7 @@ private: Table<3, double> interior_weights_abf; - /** - * Allow access from other dimensions. - */ + // Allow access from other dimensions. template friend class FE_ABF; }; diff --git a/include/deal.II/fe/fe_dgp_nonparametric.h b/include/deal.II/fe/fe_dgp_nonparametric.h index 80a5654271..57a4007dd2 100644 --- a/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/include/deal.II/fe/fe_dgp_nonparametric.h @@ -579,9 +579,7 @@ private: */ const PolynomialSpace polynomial_space; - /** - * Allow access from other dimensions. - */ + // Allow access from other dimensions. template friend class FE_DGPNonparametric; }; diff --git a/include/deal.II/fe/fe_dgq.h b/include/deal.II/fe/fe_dgq.h index de3c697509..c4fc6ffa61 100644 --- a/include/deal.II/fe/fe_dgq.h +++ b/include/deal.II/fe/fe_dgq.h @@ -377,15 +377,11 @@ private: */ mutable Threads::Mutex mutex; - /** - * Allow access from other dimensions. - */ + // Allow access from other dimensions. template 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 friend class MappingQ; }; diff --git a/include/deal.II/fe/fe_nedelec.h b/include/deal.II/fe/fe_nedelec.h index 0256343594..93c1541f5c 100644 --- a/include/deal.II/fe/fe_nedelec.h +++ b/include/deal.II/fe/fe_nedelec.h @@ -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 friend class FE_Nedelec; }; diff --git a/include/deal.II/fe/fe_q_base.h b/include/deal.II/fe/fe_q_base.h index 39e9c3282d..5828c6e970 100644 --- a/include/deal.II/fe/fe_q_base.h +++ b/include/deal.II/fe/fe_q_base.h @@ -330,18 +330,16 @@ protected: */ struct Implementation; - /* - * Declare implementation friend. - */ + // Declare implementation friend. friend struct FE_Q_Base::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. diff --git a/include/deal.II/fe/fe_q_hierarchical.h b/include/deal.II/fe/fe_q_hierarchical.h index f9b6d7e04f..250e98bb59 100644 --- a/include/deal.II/fe/fe_q_hierarchical.h +++ b/include/deal.II/fe/fe_q_hierarchical.h @@ -785,12 +785,10 @@ private: */ const std::vector 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 friend class FE_Q_Hierarchical; }; diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h index af43eafd16..dd4c284a68 100644 --- a/include/deal.II/fe/fe_raviart_thomas.h +++ b/include/deal.II/fe/fe_raviart_thomas.h @@ -197,9 +197,7 @@ private: */ Table<3, double> interior_weights; - /** - * Allow access from other dimensions. - */ + // Allow access from other dimensions. template friend class FE_RaviartThomas; }; diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index 06c3cc1f5c..9b59fba0a5 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -1226,7 +1226,7 @@ private: base_fe_output_objects; }; - /* + /** * Mutex for protecting initialization of restriction and embedding matrix. */ mutable Threads::Mutex mutex; diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index f9b02c014d..4a372f0e29 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -3468,10 +3468,8 @@ private: */ dealii::internal::FEValuesViews::Cache 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 friend class FEValuesViews::Scalar; template diff --git a/include/deal.II/fe/mapping.h b/include/deal.II/fe/mapping.h index e65879417f..2025514d2a 100644 --- a/include/deal.II/fe/mapping.h +++ b/include/deal.II/fe/mapping.h @@ -1233,10 +1233,8 @@ public: */ - /** - * Give class @p FEValues access to the private get_...data and - * fill_fe_...values functions. - */ + // Give class @p FEValues access to the private get_...data and + // fill_fe_...values functions. friend class FEValuesBase; friend class FEValues; friend class FEFaceValues; diff --git a/include/deal.II/fe/mapping_fe_field.h b/include/deal.II/fe/mapping_fe_field.h index ef7cd3c6bc..ccafa3a204 100644 --- a/include/deal.II/fe/mapping_fe_field.h +++ b/include/deal.II/fe/mapping_fe_field.h @@ -618,9 +618,7 @@ private: InternalData & data) const; - /** - * Declare other MappingFEField classes friends. - */ + // Declare other MappingFEField classes friends. template friend class MappingFEField; }; diff --git a/include/deal.II/fe/mapping_q_generic.h b/include/deal.II/fe/mapping_q_generic.h index 5b1f2f8409..8932a2db54 100644 --- a/include/deal.II/fe/mapping_q_generic.h +++ b/include/deal.II/fe/mapping_q_generic.h @@ -732,17 +732,13 @@ protected: const typename Triangulation::cell_iterator &cell, std::vector> & 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 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 friend class MappingQCache; }; diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index a37be90aa6..87dcb3688a 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -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 friend class TriaRawIterator; template diff --git a/include/deal.II/hp/dof_handler.h b/include/deal.II/hp/dof_handler.h index abb18fdbbc..a1b07aeb74 100644 --- a/include/deal.II/hp/dof_handler.h +++ b/include/deal.II/hp/dof_handler.h @@ -1355,9 +1355,7 @@ namespace hp */ std::vector tria_listeners; - /** - * Make accessor objects friends. - */ + // Make accessor objects friends. template friend class dealii::DoFAccessor; template @@ -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 friend class dealii::internal::hp::DoFIndicesOnFacesOrEdges; friend struct dealii::internal::hp::DoFHandlerImplementation:: diff --git a/include/deal.II/hp/dof_level.h b/include/deal.II/hp/dof_level.h index f8f1d93485..0af0ffedea 100644 --- a/include/deal.II/hp/dof_level.h +++ b/include/deal.II/hp/dof_level.h @@ -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 friend class dealii::hp::DoFHandler; friend struct dealii::internal::hp::DoFHandlerImplementation:: diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index c39fa54447..daee645f62 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -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 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 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 friend class BlockMatrixIterators::Accessor; diff --git a/include/deal.II/lac/block_sparsity_pattern.h b/include/deal.II/lac/block_sparsity_pattern.h index ae3e7d4c91..0f3c66c75b 100644 --- a/include/deal.II/lac/block_sparsity_pattern.h +++ b/include/deal.II/lac/block_sparsity_pattern.h @@ -377,10 +377,8 @@ private: */ std::vector> 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 friend class BlockSparseMatrix; }; diff --git a/include/deal.II/lac/block_vector_base.h b/include/deal.II/lac/block_vector_base.h index c037c05614..047fd2115c 100644 --- a/include/deal.II/lac/block_vector_base.h +++ b/include/deal.II/lac/block_vector_base.h @@ -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 friend class Iterator; }; @@ -971,9 +968,7 @@ protected: */ BlockIndices block_indices; - /** - * Make the iterator class a friend. - */ + // Make the iterator class a friend. template friend class dealii::internal::BlockVectorIterators::Iterator; diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index 96c2b26720..7a61c84215 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -141,9 +141,7 @@ namespace ChunkSparseMatrixIterators */ using ChunkSparsityPatternIterators::Accessor::advance; - /** - * Make iterator class a friend. - */ + // Make iterator class a friend. template friend class Iterator; }; @@ -274,9 +272,7 @@ namespace ChunkSparseMatrixIterators */ using ChunkSparsityPatternIterators::Accessor::advance; - /** - * Make iterator class a friend. - */ + // Make iterator class a friend. template friend class Iterator; }; @@ -1409,9 +1405,7 @@ private: template 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 friend class ChunkSparseMatrixIterators::Iterator; template diff --git a/include/deal.II/lac/chunk_sparsity_pattern.h b/include/deal.II/lac/chunk_sparsity_pattern.h index e2399cc4e4..85f4dfa42a 100644 --- a/include/deal.II/lac/chunk_sparsity_pattern.h +++ b/include/deal.II/lac/chunk_sparsity_pattern.h @@ -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 friend class ChunkSparseMatrix; - /** - * Make the accessor class a friend. - */ + // Make the accessor class a friend. friend class ChunkSparsityPatternIterators::Accessor; }; diff --git a/include/deal.II/lac/dynamic_sparsity_pattern.h b/include/deal.II/lac/dynamic_sparsity_pattern.h index 120b14701a..2ad9bc675c 100644 --- a/include/deal.II/lac/dynamic_sparsity_pattern.h +++ b/include/deal.II/lac/dynamic_sparsity_pattern.h @@ -155,9 +155,7 @@ namespace DynamicSparsityPatternIterators void advance(); - /** - * Grant access to iterator class. - */ + // Grant access to iterator class. friend class Iterator; }; diff --git a/include/deal.II/lac/filtered_matrix.h b/include/deal.II/lac/filtered_matrix.h index 7c190e828f..20982e4f95 100644 --- a/include/deal.II/lac/filtered_matrix.h +++ b/include/deal.II/lac/filtered_matrix.h @@ -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; }; diff --git a/include/deal.II/lac/la_parallel_vector.h b/include/deal.II/lac/la_parallel_vector.h index b8a1f0a8ef..c2bef47916 100644 --- a/include/deal.II/lac/la_parallel_vector.h +++ b/include/deal.II/lac/la_parallel_vector.h @@ -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 friend class Vector; - /** - * Make BlockVector type friends. - */ + // Make BlockVector type friends. template friend class BlockVector; }; diff --git a/include/deal.II/lac/la_vector.h b/include/deal.II/lac/la_vector.h index a4e8da0a5c..66e8f57e82 100644 --- a/include/deal.II/lac/la_vector.h +++ b/include/deal.II/lac/la_vector.h @@ -411,9 +411,7 @@ namespace LinearAlgebra friend class boost::serialization::access; - /** - * Make all other ReadWriteVector types friends. - */ + // Make all other ReadWriteVector types friends. template friend class Vector; }; diff --git a/include/deal.II/lac/matrix_iterator.h b/include/deal.II/lac/matrix_iterator.h index 636546f9eb..1b43503f0b 100644 --- a/include/deal.II/lac/matrix_iterator.h +++ b/include/deal.II/lac/matrix_iterator.h @@ -118,9 +118,7 @@ private: */ ACCESSOR accessor; - /** - * Allow other iterators access to private data. - */ + // Allow other iterators access to private data. template friend class MatrixIterator; }; diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h index bc1010a901..1b8bbc48e0 100644 --- a/include/deal.II/lac/petsc_matrix_base.h +++ b/include/deal.II/lac/petsc_matrix_base.h @@ -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 column_values; - /** - * To allow calling protected prepare_add() and prepare_set(). - */ + // To allow calling protected prepare_add() and prepare_set(). template friend class dealii::BlockMatrixBase; }; diff --git a/include/deal.II/lac/petsc_precondition.h b/include/deal.II/lac/petsc_precondition.h index 713105d811..233d547955 100644 --- a/include/deal.II/lac/petsc_precondition.h +++ b/include/deal.II/lac/petsc_precondition.h @@ -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; }; diff --git a/include/deal.II/lac/petsc_solver.h b/include/deal.II/lac/petsc_solver.h index a71660e0ec..3bca1ed1af 100644 --- a/include/deal.II/lac/petsc_solver.h +++ b/include/deal.II/lac/petsc_solver.h @@ -247,10 +247,8 @@ namespace PETScWrappers std::unique_ptr 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 }; diff --git a/include/deal.II/lac/petsc_sparse_matrix.h b/include/deal.II/lac/petsc_sparse_matrix.h index 631f23d70b..9760474f4e 100644 --- a/include/deal.II/lac/petsc_sparse_matrix.h +++ b/include/deal.II/lac/petsc_sparse_matrix.h @@ -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; }; @@ -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; }; diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h index 8eb3d04f60..5316ecd0cf 100644 --- a/include/deal.II/lac/petsc_vector_base.h +++ b/include/deal.II/lac/petsc_vector_base.h @@ -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; /** diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index 4ac093e7ed..4971b9469b 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -458,9 +458,7 @@ public: */ typename FullMatrix::const_iterator b_end; - /** - * Make enclosing class a friend. - */ + // Make enclosing class a friend. friend class const_iterator; }; diff --git a/include/deal.II/lac/read_write_vector.h b/include/deal.II/lac/read_write_vector.h index 434b2e348a..0b2ee46459 100644 --- a/include/deal.II/lac/read_write_vector.h +++ b/include/deal.II/lac/read_write_vector.h @@ -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 friend class ReadWriteVector; diff --git a/include/deal.II/lac/slepc_spectral_transformation.h b/include/deal.II/lac/slepc_spectral_transformation.h index 1b53f1235a..7763471664 100644 --- a/include/deal.II/lac/slepc_spectral_transformation.h +++ b/include/deal.II/lac/slepc_spectral_transformation.h @@ -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; }; diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index e1797cd7bb..d67f215398 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -173,9 +173,7 @@ namespace SparseMatrixIterators */ using SparsityPatternIterators::Accessor::advance; - /** - * Make iterator class a friend. - */ + // Make iterator class a friend. template friend class Iterator; }; @@ -308,9 +306,7 @@ namespace SparseMatrixIterators */ using SparsityPatternIterators::Accessor::advance; - /** - * Make iterator class a friend. - */ + // Make iterator class a friend. template friend class Iterator; }; @@ -1733,24 +1729,18 @@ private: template friend class SparseILU; - /** - * To allow it calling private prepare_add() and prepare_set(). - */ + // To allow it calling private prepare_add() and prepare_set(). template 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 friend class SparseMatrixIterators::Iterator; template 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 friend void Utilities::MPI::sum(const SparseMatrix &, diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h index a9d248ddd4..89a86beb5a 100644 --- a/include/deal.II/lac/sparse_matrix_ez.h +++ b/include/deal.II/lac/sparse_matrix_ez.h @@ -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... - */ }; /** diff --git a/include/deal.II/lac/sparse_vanka.h b/include/deal.II/lac/sparse_vanka.h index 46961cf637..0b6c4cc141 100644 --- a/include/deal.II/lac/sparse_vanka.h +++ b/include/deal.II/lac/sparse_vanka.h @@ -365,18 +365,16 @@ private: void compute_inverse(const size_type row, std::vector &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 - * x.f(), 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 + // x.f(), 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 friend class SparseBlockVanka; }; diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index b3ddd84ee3..4b73b116a2 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -243,14 +243,10 @@ namespace SparsityPatternIterators void advance(); - /** - * Grant access to iterator class. - */ + // Grant access to iterator class. friend class LinearIndexIterator; - /** - * 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 friend class SparseMatrix; template @@ -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 friend class SparseMatrix; template @@ -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; diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index 33732d99ce..13b4181ad7 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -245,9 +245,7 @@ namespace TrilinosWrappers value() const; private: - /** - * Make iterator class a friend. - */ + // Make iterator class a friend. template friend class Iterator; }; @@ -329,14 +327,11 @@ namespace TrilinosWrappers value() const; private: - /** - * Make iterator class a friend. - */ + // Make iterator class a friend. template 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; }; diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index 820af53d43..273d0ba4c8 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -158,9 +158,7 @@ namespace TrilinosWrappers void visit_present_row(); - /** - * Make enclosing class a friend. - */ + // Make enclosing class a friend. friend class Iterator; }; diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index 2eb90f7c05..a4b7c00d38 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -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; }; diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index 9d629dcb89..349729a2bc 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -1036,9 +1036,7 @@ private: mutable std::shared_ptr thread_loop_partitioner; - /** - * Make all other vector types friends. - */ + // Make all other vector types friends. template friend class Vector; }; diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index 9d91c0d55f..753fb8fc57 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -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 friend class FEEvaluationBase; template diff --git a/include/deal.II/numerics/data_out_dof_data.h b/include/deal.II/numerics/data_out_dof_data.h index b882827e45..7d6622dac4 100644 --- a/include/deal.II/numerics/data_out_dof_data.h +++ b/include/deal.II/numerics/data_out_dof_data.h @@ -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 friend class DataOut_DoFData; diff --git a/include/deal.II/particles/particle_accessor.h b/include/deal.II/particles/particle_accessor.h index f7d4b8dfd4..e773c62ec9 100644 --- a/include/deal.II/particles/particle_accessor.h +++ b/include/deal.II/particles/particle_accessor.h @@ -214,10 +214,8 @@ namespace Particles typename std::multimap>::iterator particle; - /** - * Make ParticleIterator a friend to allow it constructing - * ParticleAccessors. - */ + // Make ParticleIterator a friend to allow it constructing + // ParticleAccessors. template friend class ParticleIterator; template -- 2.39.5