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.
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;
*/
TableIndices<N> table_size;
- /**
- * Make all other table classes friends.
- */
+ // Make all other table classes friends.
template <int, typename>
friend class TableBase;
};
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>>;
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>;
};
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,
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,
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> &);
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> &);
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> &);
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> &);
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> &);
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> &);
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> &);
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> &);
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> &);
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>
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>
*/
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;
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>
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>
Table<3, double> interior_weights_abf;
- /**
- * Allow access from other dimensions.
- */
+ // Allow access from other dimensions.
template <int dim1>
friend class FE_ABF;
};
*/
const PolynomialSpace<dim> polynomial_space;
- /**
- * Allow access from other dimensions.
- */
+ // Allow access from other dimensions.
template <int, int>
friend class FE_DGPNonparametric;
};
*/
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;
};
*/
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;
};
*/
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.
*/
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;
};
*/
Table<3, double> interior_weights;
- /**
- * Allow access from other dimensions.
- */
+ // Allow access from other dimensions.
template <int dim1>
friend class FE_RaviartThomas;
};
base_fe_output_objects;
};
- /*
+ /**
* Mutex for protecting initialization of restriction and embedding matrix.
*/
mutable Threads::Mutex mutex;
*/
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>
*/
- /**
- * 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>;
InternalData & data) const;
- /**
- * Declare other MappingFEField classes friends.
- */
+ // Declare other MappingFEField classes friends.
template <int, int, class, class>
friend class MappingFEField;
};
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;
};
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>
*/
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>
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::
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::
*/
unsigned int col_block;
- /**
- * Let the iterator class be a friend.
- */
+ // Let the iterator class be a friend.
template <typename>
friend class MatrixIterator;
};
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;
};
*/
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;
*/
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;
};
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;
};
*/
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;
*/
using ChunkSparsityPatternIterators::Accessor::advance;
- /**
- * Make iterator class a friend.
- */
+ // Make iterator class a friend.
template <typename, bool>
friend class Iterator;
};
*/
using ChunkSparsityPatternIterators::Accessor::advance;
- /**
- * Make iterator class a friend.
- */
+ // Make iterator class a friend.
template <typename, bool>
friend class Iterator;
};
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>
void
advance();
- /**
- * Grant access to iterator class.
- */
+ // Grant access to iterator class.
friend class Iterator;
};
*/
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;
};
void
advance();
- /**
- * Grant access to iterator class.
- */
+ // Grant access to iterator class.
friend class Iterator;
};
* Current row number.
*/
size_type index;
- /*
- * Make enclosing class a
- * friend.
- */
+
+ // Make enclosing class a friend.
friend class const_iterator;
};
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>;
};
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;
};
friend class boost::serialization::access;
- /**
- * Make all other ReadWriteVector types friends.
- */
+ // Make all other ReadWriteVector types friends.
template <typename Number2>
friend class Vector;
};
*/
ACCESSOR accessor;
- /**
- * Allow other iterators access to private data.
- */
+ // Allow other iterators access to private data.
template <class OtherAccessor>
friend class MatrixIterator;
};
void
visit_present_row();
- /**
- * Make enclosing class a friend.
- */
+ // Make enclosing class a friend.
friend class const_iterator;
};
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;
};
*/
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;
};
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
};
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>;
};
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>;
};
*/
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
*/
mutable VectorOperation::values last_action;
- /**
- * Make the reference class a friend.
- */
+ // Make the reference class a friend.
friend class internal::VectorReference;
/**
*/
typename FullMatrix<inverse_type>::const_iterator b_end;
- /**
- * Make enclosing class a friend.
- */
+ // Make enclosing class a friend.
friend class const_iterator;
};
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;
*/
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;
};
*/
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;
};
*/
using SparsityPatternIterators::Accessor::advance;
- /**
- * Make iterator class a friend.
- */
+ // Make iterator class a friend.
template <typename, bool>
friend class Iterator;
};
*/
using SparsityPatternIterators::Accessor::advance;
- /**
- * Make iterator class a friend.
- */
+ // Make iterator class a friend.
template <typename, bool>
friend class Iterator;
};
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> &,
*/
unsigned short a_index;
- /**
- * Make enclosing class a friend.
- */
+ // Make enclosing class a friend.
friend class const_iterator;
};
* 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...
- */
};
/**
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;
};
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;
};
*/
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>
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;
*/
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>
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;
value() const;
private:
- /**
- * Make iterator class a friend.
- */
+ // Make iterator class a friend.
template <bool>
friend class Iterator;
};
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;
};
*/
bool compressed;
- /**
- * To allow calling protected prepare_add() and prepare_set().
- */
+ // To allow calling protected prepare_add() and prepare_set().
friend class BlockMatrixBase<SparseMatrix>;
};
void
visit_present_row();
- /**
- * Make enclosing class a friend.
- */
+ // Make enclosing class a friend.
friend class Iterator;
};
*/
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
*/
IndexSet owned_elements;
- /**
- * Make the reference class a friend.
- */
+ // Make the reference class a friend.
friend class internal::VectorReference;
};
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;
};
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>
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;
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>