]> https://gitweb.dealii.org/ - dealii.git/commitdiff
doxygen: stop unintentional cross-referencing of 'Function'. 11834/head
authorMarc Fehling <mafehling.git@gmail.com>
Tue, 2 Mar 2021 08:32:58 +0000 (01:32 -0700)
committerMarc Fehling <mafehling.git@gmail.com>
Tue, 2 Mar 2021 08:32:58 +0000 (01:32 -0700)
15 files changed:
include/deal.II/base/job_identifier.h
include/deal.II/base/parsed_convergence_table.h
include/deal.II/base/parsed_function.h
include/deal.II/distributed/cell_data_transfer.h
include/deal.II/hp/fe_collection.h
include/deal.II/lac/lapack_support.h
include/deal.II/lac/matrix_out.h
include/deal.II/lac/petsc_solver.h
include/deal.II/matrix_free/operators.h
include/deal.II/matrix_free/task_info.h
include/deal.II/multigrid/mg_transfer_global_coarsening.h
include/deal.II/numerics/cell_data_transfer.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/sundials/kinsol.h
include/deal.II/sundials/sunlinsol_wrapper.h

index 5ca01a853bc552d60dc816c8fbc687edcc9bdb30..fc974549a491cbf53ee192bbccb699efaf8ba7a6 100644 (file)
@@ -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();
index a2b6d19492156aa411267b0dbbebb01084e0a646..78ebdc0640b3439ca2f0baf3c4484d122e3133b8 100644 (file)
@@ -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
index 89f0b35ec14c65913ffeb148bc79ddebb98fac98..be1f840393d780cd3e922fdb9db6f34375dfc1fd 100644 (file)
@@ -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
index 9803e9815522ef0b240d375c620f40d0529f36c5..d0b6e3d763dae47a4db58346de6a512f6808014b 100644 (file)
@@ -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<dim, spacedim>
@@ -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<std::vector<value_type>(
@@ -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<value_type(
index 3ff44f2b2fafadff9e2faab926f6e3c7ed8f5a6b..142611c502d974869f9d1e042b033e0c4c19c43e 100644 (file)
@@ -528,7 +528,7 @@ namespace hp
     get_hierarchy_sequence(const unsigned int fe_index = 0) const;
 
     /**
-     * Function returning the index of the finite element following the given
+     * %Function returning the index of the finite element following the given
      * @p fe_index in hierarchy.
      *
      * By default, the index succeeding @p fe_index will be returned. If @p fe_index
@@ -540,7 +540,7 @@ namespace hp
     next_in_hierarchy(const unsigned int fe_index) const;
 
     /**
-     * Function returning the index of the finite element preceding the given
+     * %Function returning the index of the finite element preceding the given
      * @p fe_index in hierarchy.
      *
      * By default, the index preceding @p fe_index will be returned. If @p fe_index
@@ -768,7 +768,7 @@ namespace hp
       finite_elements;
 
     /**
-     * Function returning the index of the finite element following the given
+     * %Function returning the index of the finite element following the given
      * one in hierarchy.
      */
     std::function<unsigned int(const typename hp::FECollection<dim, spacedim> &,
@@ -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<unsigned int(const typename hp::FECollection<dim, spacedim> &,
index 6870e4b4c91fd9ef95a61570523ace052b9a48b2..b0f26812300f77a7c29c3075896e91aba9340ba1 100644 (file)
@@ -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)
index bc7a6bfb816b22446fb303678f688528126c022b..67cceeb91910dbb81791c422d72ae7df27470c5e 100644 (file)
@@ -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<Patch> &
index 46e7a7eea747773014d06e81068e1f5675588dcc..341d910c5b87c02f0595e35c7a9f78893938450c 100644 (file)
@@ -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
index 74f3a23e81691ba964a94219b58c285a8905325e..5afd8d8582fab689a479669d0e26c3659b03d934 100644 (file)
@@ -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
index d985c3a570a187971685edb502f80be494c695cf..d36e61a963f399662f254c805748f5d65cc658ee 100644 (file)
@@ -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<unsigned int> &      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
index c690047c563cd2b7173c7f8380970f230bd3d562..6a5063ef1085763d317768eb892ab4cec3aba5c9 100644 (file)
@@ -373,7 +373,7 @@ private:
   const MGLevelObject<MGTwoLevelTransfer<dim, VectorType>> &transfer;
 
   /**
-   * Function to initialize internal level vectors.
+   * %Function to initialize internal level vectors.
    */
   const std::function<void(const unsigned int, VectorType &)>
     initialize_dof_vector;
index 4e3fd7ed4860bf12690a3148986a755bc85f9505..94cafee5b525f3144c99126a82aab60b4785fe03 100644 (file)
@@ -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<std::vector<value_type>(
@@ -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<value_type(
index c1c09f3f99ac6814c8eef78ab6bd101c20764f51..b81493a7152a55bc19ce9523c8cd3f5fc34d3a2a 100644 (file)
@@ -1000,7 +1000,7 @@ protected:
   std::vector<Patch> 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<Patch> &
index 39031f8ac37300447b89a34282254836b722040d..869c42d6e8a43714c2725fcdb29bae8db9139b52 100644 (file)
@@ -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:
index f1996cccebe9a8161f91531b6dc0f171f8190342..4b94e1dc9b21f0f23eb482e93dcfa15d49ecfd27 100644 (file)
@@ -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;

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.