From fb10f80c3a2e8428995ed4c24c6905166e13a7d0 Mon Sep 17 00:00:00 2001 From: Marc Fehling Date: Tue, 2 Mar 2021 01:32:58 -0700 Subject: [PATCH] doxygen: stop unintentional cross-referencing of 'Function'. --- include/deal.II/base/job_identifier.h | 2 +- .../deal.II/base/parsed_convergence_table.h | 2 +- include/deal.II/base/parsed_function.h | 2 +- .../deal.II/distributed/cell_data_transfer.h | 16 ++++++------ include/deal.II/hp/fe_collection.h | 8 +++--- include/deal.II/lac/lapack_support.h | 4 +-- include/deal.II/lac/matrix_out.h | 2 +- include/deal.II/lac/petsc_solver.h | 26 +++++++++---------- include/deal.II/matrix_free/operators.h | 2 +- include/deal.II/matrix_free/task_info.h | 4 +-- .../multigrid/mg_transfer_global_coarsening.h | 2 +- include/deal.II/numerics/cell_data_transfer.h | 10 +++---- include/deal.II/numerics/data_out_dof_data.h | 2 +- include/deal.II/sundials/kinsol.h | 2 +- include/deal.II/sundials/sunlinsol_wrapper.h | 4 +-- 15 files changed, 44 insertions(+), 44 deletions(-) diff --git a/include/deal.II/base/job_identifier.h b/include/deal.II/base/job_identifier.h index 5ca01a853b..fc974549a4 100644 --- a/include/deal.II/base/job_identifier.h +++ b/include/deal.II/base/job_identifier.h @@ -67,7 +67,7 @@ public: operator()() const; /** - * Function to identify the presently running program. + * %Function to identify the presently running program. */ static const JobIdentifier & get_dealjobid(); diff --git a/include/deal.II/base/parsed_convergence_table.h b/include/deal.II/base/parsed_convergence_table.h index a2b6d19492..78ebdc0640 100644 --- a/include/deal.II/base/parsed_convergence_table.h +++ b/include/deal.II/base/parsed_convergence_table.h @@ -345,7 +345,7 @@ public: * * * @param column_name Name of the column to add; - * @param custom_function Function that will be called to fill the given + * @param custom_function %Function that will be called to fill the given * entry. You need to make sure that the scope of this function is valid * up to the call to error_from_exact() or difference(); * @param compute_rate If set to true, then this column will be included in diff --git a/include/deal.II/base/parsed_function.h b/include/deal.II/base/parsed_function.h index 89f0b35ec1..be1f840393 100644 --- a/include/deal.II/base/parsed_function.h +++ b/include/deal.II/base/parsed_function.h @@ -128,7 +128,7 @@ namespace Functions * * @endcode * - * Function constants is a collection of pairs in the form name=value, + * %Function constants is a collection of pairs in the form name=value, * separated by commas, for example: * * @code diff --git a/include/deal.II/distributed/cell_data_transfer.h b/include/deal.II/distributed/cell_data_transfer.h index 9803e98155..d0b6e3d763 100644 --- a/include/deal.II/distributed/cell_data_transfer.h +++ b/include/deal.II/distributed/cell_data_transfer.h @@ -214,10 +214,10 @@ namespace parallel * container stores values that differ in size. A varying amount of data * may be packed per cell, if for example the underlying ValueType of * the VectorType container is a container itself. - * @param[in] refinement_strategy Function deciding how data will be - * stored on refined cells from its parent cell. - * @param[in] coarsening_strategy Function deciding which data to store on - * a cell whose children will get coarsened into. + * @param[in] refinement_strategy %Function deciding how data will be + * stored on refined cells from its parent cell. + * @param[in] coarsening_strategy %Function deciding which data to store + * on a cell whose children will get coarsened into. */ CellDataTransfer( const parallel::distributed::Triangulation @@ -246,8 +246,8 @@ namespace parallel * container stores values that differ in size. A varying amount of data * may be packed per cell, if for example the underlying ValueType of * the VectorType container is a container itself. - * @param[in] coarsening_strategy Function deciding which data to store on - * a cell whose children will get coarsened into. + * @param[in] coarsening_strategy %Function deciding which data to store + * on a cell whose children will get coarsened into. * * @deprecated Use the above constructor instead. */ @@ -341,7 +341,7 @@ namespace parallel const bool transfer_variable_size_data; /** - * Function deciding how data will be stored on refined cells from its + * %Function deciding how data will be stored on refined cells from its * parent cell. */ const std::function( @@ -350,7 +350,7 @@ namespace parallel refinement_strategy; /** - * Function deciding on how to process data from children to be stored on + * %Function deciding on how to process data from children to be stored on * the parent cell. */ const std::function &, @@ -776,7 +776,7 @@ namespace hp hierarchy_next; /** - * Function returning the index of the finite element preceding the given + * %Function returning the index of the finite element preceding the given * one in hierarchy. */ std::function &, diff --git a/include/deal.II/lac/lapack_support.h b/include/deal.II/lac/lapack_support.h index 6870e4b4c9..b0f2681230 100644 --- a/include/deal.II/lac/lapack_support.h +++ b/include/deal.II/lac/lapack_support.h @@ -73,7 +73,7 @@ namespace LAPACKSupport }; /** - * Function printing the name of a State. + * %Function printing the name of a State. */ inline const char * state_name(State s) @@ -122,7 +122,7 @@ namespace LAPACKSupport }; /** - * Function printing the name of a Property. + * %Function printing the name of a Property. */ inline const char * property_name(const Property s) diff --git a/include/deal.II/lac/matrix_out.h b/include/deal.II/lac/matrix_out.h index bc7a6bfb81..67cceeb919 100644 --- a/include/deal.II/lac/matrix_out.h +++ b/include/deal.II/lac/matrix_out.h @@ -161,7 +161,7 @@ private: std::string name; /** - * Function by which the base class's functions get to know what patches + * %Function by which the base class's functions get to know what patches * they shall write to a file. */ virtual const std::vector & diff --git a/include/deal.II/lac/petsc_solver.h b/include/deal.II/lac/petsc_solver.h index 46e7a7eea7..341d910c5b 100644 --- a/include/deal.II/lac/petsc_solver.h +++ b/include/deal.II/lac/petsc_solver.h @@ -186,7 +186,7 @@ namespace PETScWrappers const MPI_Comm mpi_communicator; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is requested by the derived class. */ virtual void @@ -311,7 +311,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -362,7 +362,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -412,7 +412,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -462,7 +462,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -529,7 +529,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -580,7 +580,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -629,7 +629,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -679,7 +679,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -734,7 +734,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -784,7 +784,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -835,7 +835,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void @@ -890,7 +890,7 @@ namespace PETScWrappers const AdditionalData additional_data; /** - * Function that takes a Krylov Subspace Solver context object, and sets + * %Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ virtual void diff --git a/include/deal.II/matrix_free/operators.h b/include/deal.II/matrix_free/operators.h index 74f3a23e81..5afd8d8582 100644 --- a/include/deal.II/matrix_free/operators.h +++ b/include/deal.II/matrix_free/operators.h @@ -475,7 +475,7 @@ namespace MatrixFreeOperators bool have_interface_matrices; /** - * Function which implements vmult_add (@p transpose = false) and + * %Function which implements vmult_add (@p transpose = false) and * Tvmult_add (@p transpose = true). */ void diff --git a/include/deal.II/matrix_free/task_info.h b/include/deal.II/matrix_free/task_info.h index d985c3a570..d36e61a963 100644 --- a/include/deal.II/matrix_free/task_info.h +++ b/include/deal.II/matrix_free/task_info.h @@ -336,7 +336,7 @@ namespace internal DynamicSparsityPattern & connectivity_blocks) const; /** - * Function to create coloring on the second layer within each + * %Function to create coloring on the second layer within each * partition. */ void @@ -349,7 +349,7 @@ namespace internal std::vector & partition_color_list); /** - * Function to create partitioning on the second layer within each + * %Function to create partitioning on the second layer within each * partition. */ void diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.h index c690047c56..6a5063ef10 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.h @@ -373,7 +373,7 @@ private: const MGLevelObject> &transfer; /** - * Function to initialize internal level vectors. + * %Function to initialize internal level vectors. */ const std::function initialize_dof_vector; diff --git a/include/deal.II/numerics/cell_data_transfer.h b/include/deal.II/numerics/cell_data_transfer.h index 4e3fd7ed48..94cafee5b5 100644 --- a/include/deal.II/numerics/cell_data_transfer.h +++ b/include/deal.II/numerics/cell_data_transfer.h @@ -119,9 +119,9 @@ public: * @param[in] triangulation The triangulation on which all operations will * happen. At the time when this constructor is called, the refinement * in question has not happened yet. - * @param[in] refinement_strategy Function deciding how data will be stored on - * refined cells from its parent cell. - * @param[in] coarsening_strategy Function deciding which data to store on + * @param[in] refinement_strategy %Function deciding how data will be stored + * on refined cells from its parent cell. + * @param[in] coarsening_strategy %Function deciding which data to store on * a cell whose children will get coarsened into. */ CellDataTransfer( @@ -165,7 +165,7 @@ private: triangulation; /** - * Function deciding how data will be stored on refined cells from its parent + * %Function deciding how data will be stored on refined cells from its parent * cell. */ const std::function( @@ -174,7 +174,7 @@ private: refinement_strategy; /** - * Function deciding on how to process data from children to be stored on the + * %Function deciding on how to process data from children to be stored on the * parent cell. */ const std::function patches; /** - * Function by which the base class's functions get to know what patches + * %Function by which the base class's functions get to know what patches * they shall write to a file. */ virtual const std::vector & diff --git a/include/deal.II/sundials/kinsol.h b/include/deal.II/sundials/kinsol.h index 39031f8ac3..869c42d6e8 100644 --- a/include/deal.II/sundials/kinsol.h +++ b/include/deal.II/sundials/kinsol.h @@ -241,7 +241,7 @@ namespace SUNDIALS * @param strategy Solution strategy * @param maximum_non_linear_iterations Maximum number of nonlinear * iterations - * @param function_tolerance Function norm stopping tolerance + * @param function_tolerance %Function norm stopping tolerance * @param step_tolerance Scaled step stopping tolerance * * Newton parameters: diff --git a/include/deal.II/sundials/sunlinsol_wrapper.h b/include/deal.II/sundials/sunlinsol_wrapper.h index f1996ccceb..4b94e1dc9b 100644 --- a/include/deal.II/sundials/sunlinsol_wrapper.h +++ b/include/deal.II/sundials/sunlinsol_wrapper.h @@ -66,7 +66,7 @@ namespace SUNDIALS void *A_data; /** - * Function pointer declared by SUNDIALS to evaluate the matrix vector + * %Function pointer declared by SUNDIALS to evaluate the matrix vector * product. */ ATimesFn a_times_fn; @@ -109,7 +109,7 @@ namespace SUNDIALS void *P_data; /** - * Function pointer to a function that computes the preconditioner + * %Function pointer to a function that computes the preconditioner * application. */ PSolveFn p_solve_fn; -- 2.39.5