]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Avoid using 'info' as a word. 6283/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Sat, 21 Apr 2018 19:12:36 +0000 (13:12 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sat, 21 Apr 2018 19:12:36 +0000 (13:12 -0600)
Use 'information' instead, or if it refers to a variable then at least mark it up.

13 files changed:
include/deal.II/dofs/dof_tools.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/sparse_direct.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/meshworker/assembler.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/functional.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/output.h
include/deal.II/meshworker/simple.h
include/deal.II/numerics/point_value_history.h

index 9871fa37f08714b3a91bedcdacccda9ed4def8c4..45297c057c00fd3285dd77cfe31dda9fb7f610d3 100644 (file)
@@ -2401,8 +2401,8 @@ namespace DoFTools
    * @image html support_point_dofs2.png
    * </p>
    *
-   * To generate the mesh and the support point info in a single gnuplot file,
-   * use code similar to
+   * To generate the mesh and the support point information in a
+   * single gnuplot file, use code similar to
    * @code
    * std::ofstream out("gnuplot.gpl");
    * out << "plot '-' using 1:2 with lines, '-' with labels point pt 2 offset 1,1" << std::endl;
index 62e2e5109375cd202e0f549d7d1d9fa244e5fa27..d0a18a58e65585186bd770da2729e7c299dcc959 100644 (file)
@@ -136,37 +136,37 @@ public:
   void set_control(SolverControl &ctrl);
 
   /**
-   * Set the additional data. For more info see the @p Solver class.
+   * Set the additional data. For more information see the @p Solver class.
    */
   void set_data(const typename SolverRichardson<VectorType>
                 ::AdditionalData &data);
 
   /**
-   * Set the additional data. For more info see the @p Solver class.
+   * Set the additional data. For more information see the @p Solver class.
    */
   void set_data(const typename SolverCG<VectorType>
                 ::AdditionalData &data);
 
   /**
-   * Set the additional data. For more info see the @p Solver class.
+   * Set the additional data. For more information see the @p Solver class.
    */
   void set_data(const typename SolverMinRes<VectorType>
                 ::AdditionalData &data);
 
   /**
-   * Set the additional data. For more info see the @p Solver class.
+   * Set the additional data. For more information see the @p Solver class.
    */
   void set_data(const typename SolverBicgstab<VectorType>
                 ::AdditionalData &data);
 
   /**
-   * Set the additional data. For more info see the @p Solver class.
+   * Set the additional data. For more information see the @p Solver class.
    */
   void set_data(const typename SolverGMRES<VectorType>
                 ::AdditionalData &data);
 
   /**
-   * Set the additional data. For more info see the @p Solver class.
+   * Set the additional data. For more information see the @p Solver class.
    */
   void set_data(const typename SolverFGMRES<VectorType>
                 ::AdditionalData &data);
index 53ebeefe60d2c2259ebb09700dd9e41b1161e3f2..733d30c02bd53c2e84dbe1142c67a759e539c39b 100644 (file)
@@ -346,7 +346,7 @@ private:
   std::vector<double> Ax;
 
   /**
-   * Control and info arrays for the solver routines.
+   * Control and work arrays for the solver routines.
    */
   std::vector<double> control;
 };
index f2cd73a4a693abbd7d23456dce96efde55c35aad..bd02d7d109933c40d618017ae3debe8aaa49b3b4 100644 (file)
@@ -58,7 +58,7 @@ template <typename> class VectorizedArray;
  * @tparam Number Arithmetic type of the underlying array elements.
  *
  * @tparam size Compile-time array lengths. By default at -1, which means that
- * the run-time info stored in the matrices passed to the reinit()
+ * the run-time information stored in the matrices passed to the reinit()
  * function is used.
  *
  * @author Martin Kronbichler and Julius Witte, 2017
@@ -206,7 +206,7 @@ private:
  * float and double numbers.
  *
  * @tparam size Compile-time array lengths. By default at -1, which means that
- * the run-time info stored in the matrices passed to the reinit()
+ * the run-time information stored in the matrices passed to the reinit()
  * function is used.
  *
  * @author Martin Kronbichler and Julius Witte, 2017
index c30dc9faf76b16d7178f9b772636fdcd61fa2dfa..6057a82aaf72ecfae819e6824ee80363532a830c 100644 (file)
@@ -1951,7 +1951,7 @@ public:
   /**
    * Constructor for the reduced functionality. Similar to the other
    * constructor with FiniteElement argument but using another
-   * FEEvaluationBase object to provide info about the geometry. This allows
+   * FEEvaluationBase object to provide information about the geometry. This allows
    * several FEEvaluation objects to share the geometry evaluation, i.e., the
    * underlying mapping and quadrature points do only need to be evaluated
    * once. Make sure to not pass an optional object around when you intend to
index 2b0da3d263871b94ad74bac6eb64b2936d69e151..0b59eea80d96972cbd2c629cf20c12e45f45705e 100644 (file)
@@ -120,7 +120,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
@@ -217,7 +217,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
@@ -341,7 +341,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
index 91ce0eb259df660fea1545b7ac818ec3af2b50b2..e7ac6d5af36a03dc83e01f8fee0630f2b1679389 100644 (file)
@@ -78,7 +78,7 @@ namespace MeshWorker
     /**
      * The number of the current face on the current cell.
      *
-     * This number is numbers::invalid_unsigned_int if the info object was
+     * This number is numbers::invalid_unsigned_int if the @p info object was
      * initialized with a cell.
      */
     unsigned int face_number;
@@ -86,7 +86,7 @@ namespace MeshWorker
     /**
      * The number of the current subface on the current face
      *
-     * This number is numbers::invalid_unsigned_int if the info object was not
+     * This number is numbers::invalid_unsigned_int if the @p info object was not
      * initialized with a subface.
      */
     unsigned int sub_number;
@@ -226,7 +226,7 @@ namespace MeshWorker
     void reset();
 
     /**
-     * After all info objects have been filled appropriately, use the
+     * After all DOFINFO objects have been filled appropriately, use the
      * ASSEMBLER object to assemble them into the global data. See
      * MeshWorker::Assembler for available classes.
      */
index d51ba801b938e9487f33e9e160583930d66276a2..ab1ab32037ecc95bb49572f86d00772117134568 100644 (file)
@@ -53,7 +53,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
@@ -122,7 +122,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
index dbaac81c031942ea043cea503a10b2ddf98a49e9..1012307ada26b297ffb4d8a26103cd34711e18f0 100644 (file)
@@ -284,7 +284,7 @@ namespace MeshWorker
   public:
 
     /**
-     * The type of the info object for cells.
+     * The type of the @p info object for cells.
      */
     typedef IntegrationInfo<dim, spacedim> CellInfo;
 
@@ -524,24 +524,24 @@ namespace MeshWorker
     void post_faces(const DoFInfoBox<dim, DOFINFO> &);
 
     /**
-     * The info object for a cell.
+     * The @p info object for a cell.
      */
     CellInfo cell;
     /**
-     * The info object for a boundary face.
+     * The @p info object for a boundary face.
      */
     CellInfo boundary;
     /**
-     * The info object for a regular interior face, seen from the first cell.
+     * The @p info object for a regular interior face, seen from the first cell.
      */
     CellInfo face;
     /**
-     * The info object for the refined side of an interior face seen from the
+     * The @p info object for the refined side of an interior face seen from the
      * first cell.
      */
     CellInfo subface;
     /**
-     * The info object for an interior face, seen from the other cell.
+     * The @p info object for an interior face, seen from the other cell.
      */
     CellInfo neighbor;
 
index 8cae45718279af98a67156a1eb207d950a00177d..97ddf2614584a8564eedf5cd2f9ee5211e58b2b9 100644 (file)
@@ -40,7 +40,7 @@ class BlockIndices;
  * integration_loop() instead.
  *
  * The loop() depends on certain objects handed to it as arguments. These
- * objects are of two types, info objects like DoFInfo and IntegrationInfo and
+ * objects are of two types, @p info objects like DoFInfo and IntegrationInfo and
  * worker objects like LocalWorker and IntegrationWorker.
  *
  * Worker objects usually do two different jobs: first, they compute the local
@@ -198,7 +198,7 @@ namespace MeshWorker
    * with matrix(), using the second argument <tt>true</tt>.
    * </ol>
    *
-   * The local matrices initialized by reinit() of the info object and then
+   * The local matrices initialized by reinit() of the @p info object and then
    * assembled into the global system by Assembler classes.
    *
    * @ingroup MeshWorker
index 681e1a8cd7ab553d418f33cacb4eb4ffe3ba17b0..7791454701f0f5c857a259cc4037e68890db163e 100644 (file)
@@ -84,7 +84,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <int dim>
index 42ced6897cf821e5fcee6229eb35fa0718d08fa1..5f89c10902191bef52c7c712702921cc5a52590f 100644 (file)
@@ -86,7 +86,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
@@ -184,7 +184,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
@@ -199,7 +199,7 @@ namespace MeshWorker
 
       /**
        * Assemble all local matrices associated with an interior face in the
-       * info objects into the global matrix.
+       * @p info1 and @p info2 objects into the global matrix.
        */
       template <class DOFINFO>
       void assemble(const DOFINFO &info1,
@@ -282,7 +282,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
@@ -295,8 +295,8 @@ namespace MeshWorker
       void assemble(const DOFINFO &info);
 
       /**
-       * Assemble both local matrices in the info objects into the global
-       * matrices.
+       * Assemble both local matrices in the @p info1 and @p info2
+       * objects into the global matrices.
        */
       template <class DOFINFO>
       void assemble(const DOFINFO &info1,
@@ -440,7 +440,7 @@ namespace MeshWorker
        * Initialize the local data in the DoFInfo object used later for
        * assembling.
        *
-       * The info object refers to a cell if <code>!face</code>, or else to an
+       * The @p info object refers to a cell if <code>!face</code>, or else to an
        * interior or boundary face.
        */
       template <class DOFINFO>
@@ -453,8 +453,8 @@ namespace MeshWorker
       void assemble(const DOFINFO &info);
 
       /**
-       * Assemble both local matrices in the info objects into the global
-       * matrix.
+       * Assemble both local matrices in the @p info1 and @p info2
+       * objects into the global matrix.
        */
       template <class DOFINFO>
       void assemble(const DOFINFO &info1,
index 84c84870d69e15bfe07b47127fb2f9ddca2a9a22..1587fccc6ead10361a4a23932c70ece3329d312d 100644 (file)
@@ -393,7 +393,7 @@ public:
 
   /**
    * Write out a series of .gpl files named base_name + "-00.gpl", base_name +
-   * "-01.gpl" etc. The data file gives info about where the support points
+   * "-01.gpl" etc. The data file gives information about where the support points
    * selected and interpreting the data. If @p n_indep != 0 an additional file
    * base_name + "_indep.gpl" containing key and independent data. The file
    * name agrees with the order the points were added to the class. The names
@@ -588,7 +588,7 @@ private:
   std::map <std::string, std::vector<std::string> > component_names_map;
 
   /**
-   * Save the location and other mesh info about support points.
+   * Save the location and other mesh information about support points.
    */
   std::vector <internal::PointValueHistoryImplementation::PointGeometryData <dim> >
   point_geometry_data;

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.