]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Spell 'set up' when used as a verb 15412/head
authorMartin Kronbichler <martin.kronbichler@uni-a.de>
Wed, 21 Jun 2023 06:06:29 +0000 (08:06 +0200)
committerMartin Kronbichler <martin.kronbichler@uni-a.de>
Wed, 21 Jun 2023 06:08:20 +0000 (08:08 +0200)
include/deal.II/base/process_grid.h
include/deal.II/differentiation/ad/sacado_number_types.h
include/deal.II/lac/ginkgo_solver.h
include/deal.II/lac/petsc_block_vector.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/numerics/point_value_history.h
include/deal.II/trilinos/nox.templates.h
source/base/mpi_noncontiguous_partitioner.cc
source/base/partitioner.cc
source/distributed/repartitioning_policy_tools.cc
source/numerics/point_value_history.cc

index 9c3b427ab1ac77b9c5a739d0d9ac06a86a549e28..f6dd9bbafb1bc2bb8e9c826a785c34c1deb369b3 100644 (file)
@@ -52,7 +52,7 @@ namespace Utilities
      * A shared pointer to this class is provided to ScaLAPACKMatrix matrices to
      * perform block-cyclic distribution.
      *
-     * Note that this class allows to setup a process grid which has fewer
+     * Note that this class allows to set up a process grid which has fewer
      * MPI cores than the total number of cores in the communicator.
      *
      * Currently the only place where one would use a ProcessGrid object is
index 9680e7b37d973bd6f0a41bc8fd676edbac850333..82112d1b3cec5c9536aa98794e3ddb18acd5a51d 100644 (file)
@@ -337,7 +337,7 @@ namespace Differentiation
           // For Sacado::Rad::ADvar numbers, we have to initialize the
           // ADNumber with an already fully-configured value. This means
           // that if this nests another ADNumber then the nested number
-          // must already be setup and ready for use.
+          // must already be set up and ready for use.
 
           // Initialize potential nested directional derivatives
           derivative_type derivative_initializer;
index f9f5889010aa70ba9a6952597b1a8fcb7c034842..ec7bbf0f9d2cb5e5b38f86ab03a1a5033bd106db 100644 (file)
@@ -225,7 +225,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the CG solver from the CG factory which
+     * set the parameters and set up the CG solver from the CG factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the CG solver.
@@ -240,7 +240,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the CG solver from the CG factory which
+     * set the parameters and set up the CG solver from the CG factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the CG solver.
@@ -281,7 +281,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the Bicgstab solver from the Bicgstab
+     * set the parameters and set up the Bicgstab solver from the Bicgstab
      * factory which solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the Bicgstab solver.
@@ -296,7 +296,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the Bicgstab solver from the Bicgstab
+     * set the parameters and set up the Bicgstab solver from the Bicgstab
      * factory which solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the Bicgstab solver.
@@ -339,7 +339,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the CGS solver from the CGS factory which
+     * set the parameters and set up the CGS solver from the CGS factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the CGS solver.
@@ -354,7 +354,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the CGS solver from the CGS factory which
+     * set the parameters and set up the CGS solver from the CGS factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the CGS solver.
@@ -406,7 +406,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the FCG solver from the FCG factory which
+     * set the parameters and set up the FCG solver from the FCG factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the FCG solver.
@@ -421,7 +421,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the FCG solver from the FCG factory which
+     * set the parameters and set up the FCG solver from the FCG factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the FCG solver.
@@ -472,7 +472,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the GMRES solver from the GMRES factory
+     * set the parameters and set up the GMRES solver from the GMRES factory
      * which solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the GMRES solver.
@@ -487,7 +487,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the GMRES solver from the GMRES factory
+     * set the parameters and set up the GMRES solver from the GMRES factory
      * which solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the GMRES solver.
@@ -531,7 +531,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the IR solver from the IR factory which
+     * set the parameters and set up the IR solver from the IR factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the IR solver.
@@ -546,7 +546,7 @@ namespace GinkgoWrappers
      * Constructor.
      *
      * @param[in,out] solver_control The solver control object is then used to
-     * set the parameters and setup the IR solver from the IR factory which
+     * set the parameters and set up the IR solver from the IR factory which
      * solves the linear system.
      *
      * @param[in] exec_type The execution paradigm for the IR solver.
index cc69935ed54b5b81ce8cc4778b25cd08c75b9597..642e0e71d44a979b7744c45de9f3c86f23bb97a2 100644 (file)
@@ -365,7 +365,7 @@ namespace PETScWrappers
       Vec petsc_nest_vector;
 
       /**
-       * Utility to setup the VECNEST object
+       * Utility to set up the VECNEST object
        */
       void
       setup_nest_vec();
index 411c59c942e9c5e61b2644d0a2fd42c2f9cd2db1..f453d5b150edfce13d4c902c551af3c3c6025d61 100644 (file)
@@ -582,7 +582,7 @@ namespace internal
 
           univariate_shape_data.nodal_at_cell_boundaries = true;
 
-          // TODO: setup face_to_cell_index_nodal, face_to_cell_index_hermite,
+          // TODO: set up face_to_cell_index_nodal, face_to_cell_index_hermite,
           //  face_orientations
 
           return;
index 54db549e4a0c7e7f09e930406bf3c5d36ef96544..b1a3401f5949b4ee52af557dc9ab2835ece7bc9a 100644 (file)
@@ -175,8 +175,8 @@ namespace internal
  * #include <deal.II/numerics/point_value_history.h>
  * //....
  *
- * //... code to setup Triangulation, perform any refinement necessary
- * // and setup DoFHandler, sizing solution Vectors etc
+ * //... code to set up Triangulation, perform any refinement necessary
+ * // and set up DoFHandler, sizing solution Vectors etc
  *
  * // just one independent value, which happens to be an input
  * unsigned int n_inputs = 1;
@@ -184,7 +184,7 @@ namespace internal
  * // call the constructor
  * PointValueHistory<dim> node_monitor(dof_handler, n_inputs);
  *
- * // setup fields and points required
+ * // set up fields and points required
  * node_monitor.add_field_name("Solution");
  * std::vector <Point <dim> > point_vector(2);
  * point_vector[0] = Point <dim>(0, 0);
index f91a9784b881dad01d32f7d45c8de89117dd45c3..b33fcfa06755c9df79aeff16bd3dfaa7db30ff56 100644 (file)
@@ -355,7 +355,7 @@ namespace TrilinosWrappers
       public:
         /**
          * Constructor. The class is initialized by the solution vector and
-         * functions to compute the residual, to setup the jacobian, and
+         * functions to compute the residual, to set up the jacobian, and
          * to solve the Jacobian.
          */
         Group(
@@ -768,7 +768,7 @@ namespace TrilinosWrappers
         std::function<int(const VectorType &x, VectorType &f)> residual;
 
         /**
-         * A helper function to setup Jacobian.
+         * A helper function to set up Jacobian.
          */
         std::function<int(const VectorType &x)> setup_jacobian;
 
index 6a00ef16fdfc2e3c469a0df6a1dad3184b49dda9..3f4ba90765c205ddc3650aa379c03425bf80be6d 100644 (file)
@@ -105,7 +105,7 @@ namespace Utilities
       buffers.clear();
       requests.clear();
 
-      // setup communication pattern
+      // set up communication pattern
       std::vector<unsigned int> owning_ranks_of_ghosts(
         indexset_want.n_elements());
 
@@ -124,7 +124,7 @@ namespace Utilities
         consensus_algorithm;
       consensus_algorithm.run(process, communicator);
 
-      // setup map of processes from where this rank will receive values
+      // set up map of processes from where this rank will receive values
       {
         std::map<unsigned int, std::vector<types::global_dof_index>> recv_map;
 
@@ -215,7 +215,7 @@ namespace Utilities
       index_set_want.add_indices(indices_want_clean.begin(),
                                  indices_want_clean.end());
 
-      // step 2) setup internal data structures with indexset
+      // step 2) set up internal data structures with indexset
       this->reinit(index_set_has, index_set_want, communicator);
 
       // step 3) fix inner data structures so that it is sorted as
index 9f4a47542a590bbc62a917836627e3ad3c2bf319..4c0177ee40f31e67c60f80440d0d34dcb4e51068 100644 (file)
@@ -314,7 +314,7 @@ namespace Utilities
       // find how much the individual processes that want import from me
       std::map<unsigned int, IndexSet> import_data = process.get_requesters();
 
-      // count import requests and setup the compressed indices
+      // count import requests and set up the compressed indices
       n_import_indices_data = 0;
       import_targets_data   = {};
       import_targets_data.reserve(import_data.size());
index e1deb26c1bbb6f60a0d6fcca8d723bcc6f20512a..4e77977e7132d15c00df1b7862d14a9892704dd8 100644 (file)
@@ -329,7 +329,7 @@ namespace RepartitioningPolicyTools
                 mpi_communicator);
     AssertThrowMPI(ierr);
 
-    // setup partition
+    // set up partition
     LinearAlgebra::distributed::Vector<double> partition(partitioner);
 
     for (std::uint64_t i = 0, weight = process_local_weight_offset;
index 74ece23a4919be63d3739002d2082bcf2fc46075..cbb5f920053e39ee9e7bf0f03efd0ebf8ecfadea 100644 (file)
@@ -227,8 +227,7 @@ PointValueHistory<dim>::add_point(const Point<dim> &location)
   for (unsigned int support_point = 0; support_point < n_support_points;
        support_point++)
     {
-      // setup valid data in the empty
-      // vectors
+      // set up valid data in the empty vectors
       unsigned int component =
         dof_handler->get_fe().system_to_component_index(support_point).first;
       current_points[component]   = fe_values.quadrature_point(support_point);
@@ -373,8 +372,7 @@ PointValueHistory<dim>::add_points(const std::vector<Point<dim>> &locations)
   for (unsigned int support_point = 0; support_point < n_support_points;
        support_point++)
     {
-      // setup valid data in the empty
-      // vectors
+      // set up valid data in the empty vectors
       unsigned int component =
         dof_handler->get_fe().system_to_component_index(support_point).first;
       temp_points[component]   = fe_values.quadrature_point(support_point);

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.