]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use American English spelling for 'initialize'. 15030/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Wed, 5 Apr 2023 19:50:08 +0000 (13:50 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 5 Apr 2023 19:50:08 +0000 (13:50 -0600)
include/deal.II/differentiation/ad/ad_number_traits.h
include/deal.II/differentiation/ad/sacado_number_types.h
include/deal.II/fe/fe_interface_values.h
source/lac/scalapack.cc

index 11fa8461380f7522f7c889f5643a88ac9755132a..c4eff47f7ee83505d5607241232490eca9f7479a 100644 (file)
@@ -347,7 +347,7 @@ namespace Differentiation
          * Initialize the state of an independent variable.
          *
          * With a nested marking approach it is sometimes
-         * necessary to initialise the value of an intermediate
+         * necessary to initialize the value of an intermediate
          * value that may be a floating point number.
          */
         template <typename ADNumberType>
index e1779f2fb2eee95ded5cd1c9ae755a11fedbdffc..b497f7cbbfdde98767f9b34f2c0aefc334a68de6 100644 (file)
@@ -291,7 +291,7 @@ namespace Differentiation
                              const unsigned int n_independent_variables,
                              ad_type &          out)
         {
-          // It is required that we first initialise the outer number before
+          // It is required that we first initialize the outer number before
           // any of the nested ones.
           out = ad_type(n_independent_variables, index, in);
 
index 2d3d1cd2716a1a9bc849f579ce1129d3b0e6dab6..27493ef784be10e5bf800c680d1f317acac7359f 100644 (file)
@@ -1482,17 +1482,17 @@ public:
    * @param[in] q_index If left at its default, use the quadrature formula
    * within the hp::QCollection passed to the constructor as given by the
    * dominating finite element across the interface (only used if the
-   * FEInterface object is initialised with an hp::FECollection, an
+   * FEInterface object is initialized with an hp::FECollection, an
    * hp::QCollection, and possibly an hp::MappingCollection).
    * @param[in] mapping_index If left at its default, use the mapping within the
    * hp::MappingCollection passed to the constructor as given by the dominating
    * finite element across the interface (only used if the FEInterface object
-   * is initialised with an hp::FECollection, an hp::QCollection, and possibly
+   * is initialized with an hp::FECollection, an hp::QCollection, and possibly
    * an hp::MappingCollection).
    * @param[in] fe_index If left at its default, use the finite element within
    * the hp::FECollection passed to the constructor as given by the dominating
    * finite element across the interface (only used if the FEInterface object
-   * is initialised with an hp::FECollection, an hp::QCollection, and possibly
+   * is initialized with an hp::FECollection, an hp::QCollection, and possibly
    * an hp::MappingCollection).
    */
   template <class CellIteratorType, class CellNeighborIteratorType>
@@ -1524,17 +1524,17 @@ public:
    * @param[in] q_index If left at its default, use the quadrature formula
    * within the hp::QCollection passed to the constructor as given by the
    * dominating finite element across the interface (only used if the
-   * FEInterface object is initialised with an hp::FECollection, an
+   * FEInterface object is initialized with an hp::FECollection, an
    * hp::QCollection, and possibly an hp::MappingCollection).
    * @param[in] mapping_index If left at its default, use the mapping within the
    * hp::MappingCollection passed to the constructor as given by the dominating
    * finite element across the interface (only used if the FEInterface object
-   * is initialised with an hp::FECollection, an hp::QCollection, and possibly
+   * is initialized with an hp::FECollection, an hp::QCollection, and possibly
    * an hp::MappingCollection).
    * @param[in] fe_index If left at its default, use the finite element within
    * the hp::FECollection passed to the constructor as given by the dominating
    * finite element across the interface (only used if the FEInterface object
-   * is initialised with an hp::FECollection, an hp::QCollection, and possibly
+   * is initialized with an hp::FECollection, an hp::QCollection, and possibly
    * an hp::MappingCollection).
    */
   template <class CellIteratorType>
index afc65d2e67a95ebcf67d23b914aa63ab019dc4fb..9d1e1341550fc7c77385394b31d0f2af9fef1923 100644 (file)
@@ -753,7 +753,7 @@ ScaLAPACKMatrix<NumberType>::copy_to(
    * The routine pgemr2d requires a BLACS context resembling at least the union
    * of process grids described by the BLACS contexts held by the ProcessGrids
    * of matrix A and B. As A and B share the same MPI communicator, there is no
-   * need to create a union MPI communicator to initialise the BLACS context
+   * need to create a union MPI communicator to initialize the BLACS context
    */
   int union_blacs_context = Csys2blacs_handle(this->grid->mpi_communicator);
   const char *order       = "Col";

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.