]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use American English. 11077/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Wed, 21 Oct 2020 22:30:37 +0000 (16:30 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 21 Oct 2020 22:32:05 +0000 (16:32 -0600)
33 files changed:
examples/step-44/doc/intro.dox
examples/step-44/step-44.cc
include/deal.II/base/parameter_acceptor.h
include/deal.II/base/symbolic_function.h
include/deal.II/base/tensor_function.h
include/deal.II/distributed/tria.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/grid/grid_tools.h
include/deal.II/hp/fe_collection.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/schur_complement.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/vector.h
include/deal.II/numerics/time_dependent.h
include/deal.II/sundials/arkode.h
include/deal.II/sundials/ida.h
include/deal.II/sundials/kinsol.h
source/lac/trilinos_vector.cc
source/numerics/time_dependent.cc
tests/base/geometry_info_8.cc
tests/dofs/dof_tools_21_b.cc
tests/dofs/dof_tools_21_b_x.cc
tests/dofs/dof_tools_21_b_x_q3.cc
tests/dofs/dof_tools_21_b_y.cc
tests/dofs/dof_tools_21_c.cc
tests/dofs/dof_tools_22a.cc
tests/hp/hp_coarsening.cc
tests/hp/hp_coarsening.output
tests/mpi/trilinos_ghost_01.cc
tests/mpi/trilinos_ghost_02.cc
tests/mpi/trilinos_ghost_03.cc
tests/mpi/trilinos_ghost_05.cc
tests/mpi/trilinos_vector_reinit.cc

index bb8946b3d77c4350167166515720974827cd81b4..c86b0ee7d840d3c7336dfad8d6b13e79f242ede0 100644 (file)
@@ -546,7 +546,7 @@ allows $\widetilde{p}$ and $\widetilde{J}$ to be condensed out
 and a classical displacement based method is recovered.
 
 For fully-incompressible materials $\nu = 0.5$ and the three-field formulation will still exhibit
-locking behaviour.
+locking behavior.
 This can be overcome by introducing an additional constraint into the free energy of the form
 $\int_{\Omega_0} \Lambda [ \widetilde{J} - 1]~\textrm{d}V$.
 Here $\Lambda$ is a Lagrange multiplier to enforce the isochoric constraint.
index dcd39426eb93fd0e004417d1952e50ccc217eb28..0c14459b36056f6c0b61b1b4a06feb3af66cb51b 100644 (file)
@@ -488,7 +488,7 @@ namespace Step44
 
   // As discussed in the Introduction, Neo-Hookean materials are a type of
   // hyperelastic materials.  The entire domain is assumed to be composed of a
-  // compressible neo-Hookean material.  This class defines the behaviour of
+  // compressible neo-Hookean material.  This class defines the behavior of
   // this material within a three-field formulation.  Compressible neo-Hookean
   // materials can be described by a strain-energy function (SEF) $ \Psi =
   // \Psi_{\text{iso}}(\overline{\mathbf{b}}) + \Psi_{\text{vol}}(\widetilde{J})
index b0204672ad3ecc0ec4f245f7fc5c480cc3c81d6e..79693c1f9b47f3536b4de8d281b35873651faf91 100644 (file)
@@ -225,7 +225,7 @@ DEAL_II_NAMESPACE_OPEN
  * @endcode
  * Note that there is only one section "Forcing term", this is because
  * both objects have defined the same name for the section of their
- * SomeParsedClass. There are two strategies to change this behaviour. The
+ * SomeParsedClass. There are two strategies to change this behavior. The
  * first one (not recommended) would be to change the name of the section
  * of SomeParsedClass such that it contains also the string passed to
  * the constructor of MyClass:
index c207c46eebbd24c88ff2e412114365915333dbaf..42a7a3c14d80365bc5be2ef989c44bfd1dc9d5f3 100644 (file)
@@ -131,7 +131,7 @@ namespace Functions
    *
    * If you call update_user_substitution_map() and
    * set_additional_function_arguments() with the same argument, the effect on
-   * the function evaluation will be the same, however, the internal behaviour
+   * the function evaluation will be the same, however, the internal behavior
    * and function derivatives will be different. The method
    * update_user_substitution_map() performs the substitution once (the first
    * time it is required), and then stores internally a copy of the resulting
index a194b135fc15cffbb09be7c4ff0a68c993cdb3d3..33457c7c9ba9cab1e5a1243e21ed2310d9e66246 100644 (file)
@@ -39,7 +39,7 @@ DEAL_II_NAMESPACE_OPEN
  * the <tt>Function</tt> class, one can ask for a specific component only, or
  * use the <tt>vector_value</tt> function, which however does not return the
  * value, but rather writes it into the address provided by its second
- * argument. The reason for the different behaviour of the classes is that in
+ * argument. The reason for the different behavior of the classes is that in
  * the case of tensor valued functions, the size of the argument is known to
  * the compiler a priori, such that the correct amount of memory can be
  * allocated on the stack for the return value; on the other hand, for the
index 814fefbd3592ea285eae50fffb9c834da1fa2974..18e42e92abb19ca8164efddc48c553bb004259fb 100644 (file)
@@ -301,7 +301,7 @@ namespace parallel
          * every time a repartitioning in p4est happens. This can be a bit more
          * expensive, but guarantees the same memory layout and therefore cell
          * ordering in the deal.II mesh. As assembly is done in the deal.II
-         * cell ordering, this flag is required to get reproducible behaviour
+         * cell ordering, this flag is required to get reproducible behavior
          * after snapshot/resume.
          */
         mesh_reconstruction_after_repartitioning = 0x1,
index d77958f48a5c37d6ea0ed1b6b4611846d92fbe33..40b4aa5e4b74e1b30bdba2357d9d1259e5ae9dda 100644 (file)
@@ -437,7 +437,7 @@ namespace IteratorFilters
  * <h3>Initialization of filtered iterators</h3>
  *
  * Filtered iterators are given a predicate at construction time which cannot
- * be changed any more. This behaviour would be expected if the predicate
+ * be changed any more. This behavior would be expected if the predicate
  * would have been given as a template parameter to the class, but since that
  * would make the declaration of filtered iterators a nightmare, we rather
  * give the predicate as an unchangeable entity to the constructor. Note that
index d053321949436b4f9437b337a1f457de3ab56a4c..2252955399e140877e1487aaa91f8f5deb2daa33 100644 (file)
@@ -763,7 +763,7 @@ namespace GridTools
    * GridTools::regularize_corner_cells(tria);
    * tria.refine_global(2);
    * @endcode
-   * generates a mesh that has a much better behaviour w.r.t. the jacobian of
+   * generates a mesh that has a much better behavior w.r.t. the jacobian of
    * the Mapping:
    *
    * <p ALIGN="center">
index 5c319f378be9cb2faffff320bf4e293daebfeb62..7ef70c7e4e606cbe7df28a5e06c37c4267b851d5 100644 (file)
@@ -290,7 +290,7 @@ namespace hp
      * method does return true, this does not imply that the hp method will
      * work!
      *
-     * This behaviour is related to the fact, that FiniteElement classes,
+     * This behavior is related to the fact, that FiniteElement classes,
      * which provide the new style hanging node constraints might still not
      * provide them for all possible cases. If FE_Q and FE_RaviartThomas
      * elements are included in the FECollection and both properly implement
index 05d3c61f19b905d9c2161a6dba514e300a832145..4b97046f8b2164e643565160547a68c66e047b84 100644 (file)
@@ -287,7 +287,7 @@ namespace BlockMatrixIterators
 
 
 /**
- * Blocked matrix class. The behaviour of objects of this type is almost as
+ * Blocked matrix class. The behavior of objects of this type is almost as
  * for the usual matrix objects, with most of the functions being implemented
  * in both classes. The main difference is that the matrix represented by this
  * object is composed of an array of matrices (e.g. of type
index e7b58ae7a4ac5ce02970fda2038cbf4feeee2923..ad636a7ef2a0b71b5bb7155f73cb031e475d6925 100644 (file)
@@ -223,11 +223,11 @@ DEAL_II_NAMESPACE_OPEN
  * a preconditioner then the preconditioning operation is not a linear
  * operation. Here a flexible solver like SolverFGMRES (flexible GMRES) is
  * best employed as an outer solver in order to deal with the variable
- * behaviour of the preconditioner. Otherwise the iterative solver can
+ * behavior of the preconditioner. Otherwise the iterative solver can
  * stagnate somewhere near the tolerance of the preconditioner or generally
  * behave erratically. Alternatively, using a ReductionControl would ensure
  * that the preconditioner always solves to the same tolerance, thereby
- * rendering its behaviour constant.
+ * rendering its behavior constant.
  *
  * Further examples of this functionality can be found in the test-suite, such
  * as <code>tests/lac/schur_complement_01.cc</code> . The solution of a multi-
index a367d60adafa8dac836a35472e7a4aac62d5c352..7ec979b6629500409161840eb5a28e126056f140 100644 (file)
@@ -388,7 +388,7 @@ namespace SLEPcWrappers
     /**
      * SLEPc solvers will want to have an MPI communicator context over which
      * computations are parallelized. By default, this carries the same
-     * behaviour as the PETScWrappers, but you can change that.
+     * behavior as the PETScWrappers, but you can change that.
      */
     SolverKrylovSchur(SolverControl &       cn,
                       const MPI_Comm &      mpi_communicator = PETSC_COMM_SELF,
@@ -431,7 +431,7 @@ namespace SLEPcWrappers
     /**
      * SLEPc solvers will want to have an MPI communicator context over which
      * computations are parallelized. By default, this carries the same
-     * behaviour as the PETScWrappers, but you can change that.
+     * behavior as the PETScWrappers, but you can change that.
      */
     SolverArnoldi(SolverControl &       cn,
                   const MPI_Comm &      mpi_communicator = PETSC_COMM_SELF,
@@ -475,7 +475,7 @@ namespace SLEPcWrappers
     /**
      * SLEPc solvers will want to have an MPI communicator context over which
      * computations are parallelized. By default, this carries the same
-     * behaviour as the PETScWrappers, but you can change that.
+     * behavior as the PETScWrappers, but you can change that.
      */
     SolverLanczos(SolverControl &       cn,
                   const MPI_Comm &      mpi_communicator = PETSC_COMM_SELF,
@@ -507,7 +507,7 @@ namespace SLEPcWrappers
     /**
      * SLEPc solvers will want to have an MPI communicator context over which
      * computations are parallelized. By default, this carries the same
-     * behaviour as the PETScWrappers, but you can change that.
+     * behavior as the PETScWrappers, but you can change that.
      */
     SolverPower(SolverControl &       cn,
                 const MPI_Comm &      mpi_communicator = PETSC_COMM_SELF,
@@ -549,7 +549,7 @@ namespace SLEPcWrappers
     /**
      * SLEPc solvers will want to have an MPI communicator context over which
      * computations are parallelized. By default, this carries the same
-     * behaviour as the PETScWrappers, but you can change that.
+     * behavior as the PETScWrappers, but you can change that.
      */
     SolverGeneralizedDavidson(
       SolverControl &       cn,
@@ -582,7 +582,7 @@ namespace SLEPcWrappers
     /**
      * SLEPc solvers will want to have an MPI communicator context over which
      * computations are parallelized. By default, this carries the same
-     * behaviour as the PETScWrappers, but you can change that.
+     * behavior as the PETScWrappers, but you can change that.
      */
     SolverJacobiDavidson(SolverControl & cn,
                          const MPI_Comm &mpi_communicator = PETSC_COMM_SELF,
@@ -615,7 +615,7 @@ namespace SLEPcWrappers
     /**
      * SLEPc solvers will want to have an MPI communicator context over which
      * computations are parallelized. By default, this carries the same
-     * behaviour as the PETScWrappers, but you can change that.
+     * behavior as the PETScWrappers, but you can change that.
      */
     SolverLAPACK(SolverControl &       cn,
                  const MPI_Comm &      mpi_communicator = PETSC_COMM_SELF,
index 050fcb7a9bc06c9acab71c29e319f54c6245d72a..99171c9bfee12c111e6256a7acf3000597e72e64 100644 (file)
@@ -274,7 +274,7 @@ public:
    * waste some memory, so keep this in mind.  However, if <tt>N==0</tt> all
    * memory is freed, i.e. if you want to resize the vector and release the
    * memory not needed, you have to first call <tt>reinit(0)</tt> and then
-   * <tt>reinit(N)</tt>. This cited behaviour is analogous to that of the
+   * <tt>reinit(N)</tt>. This cited behavior is analogous to that of the
    * standard library containers.
    *
    * If @p omit_zeroing_entries is false, the vector is filled by zeros.
index 8808c0b8828ffbf4bc60fdf9523831a78cc7038f..db1161ed54021728dd5fcd6adb9b0ee46c906670 100644 (file)
@@ -835,7 +835,7 @@ public:
   /**
    * Compute the time difference to the last time step. If this timestep is
    * the first one, this function will result in an exception. Though this
-   * behaviour seems a bit drastic, it is appropriate in most cases since if
+   * behavior seems a bit drastic, it is appropriate in most cases since if
    * there is no previous time step you will need special treatment anyway and
    * this way no invalid value is returned which could lead to wrong but
    * unnoticed results of your computation. (The only sensible value to return
@@ -1297,7 +1297,7 @@ namespace TimeStepBase_Tria_Flags
  * change in the grids between subsequent time levels, while also trying to
  * retain the freedom of refining each grid separately. There are lots of
  * flags and numbers controlling this function, which might drastically change
- * the behaviour of the function -- see the description of the flags for
+ * the behavior of the function -- see the description of the flags for
  * further information.
  */
 template <int dim>
@@ -1339,7 +1339,7 @@ public:
 
   /**
    * Constructor. Takes a coarse grid from which the grids on this time level
-   * will be derived and some flags steering the behaviour of this object.
+   * will be derived and some flags steering the behavior of this object.
    *
    * The ownership of the coarse grid stays with the creator of this object.
    * However, it is locked from destruction to guarantee the lifetime of the
@@ -1465,7 +1465,7 @@ protected:
    * Triangulation used at this time level. Since this is something that every
    * time stepping scheme needs to have, we can safely put it into the base
    * class. Note that the triangulation is frequently deleted and rebuilt by
-   * the functions @p sleep and @p wake_up to save memory, if such a behaviour
+   * the functions @p sleep and @p wake_up to save memory, if such a behavior
    * is specified in the @p flags structure.
    */
   SmartPointer<Triangulation<dim, dim>, TimeStepBase_Tria<dim>> tria;
index c327ff5249015a2733d24206d456cfe657a89069..a2e76105b455491beff12d69449ef844676755ed 100644 (file)
@@ -410,7 +410,7 @@ namespace SUNDIALS
        * a parameter file using `prm`. The values of the parameter will be
        * updated whenever the content of `prm` is updated.
        *
-       * Make sure that this class lives longer than `prm`. Undefined behaviour
+       * Make sure that this class lives longer than `prm`. Undefined behavior
        * will occur if you destroy this class, and then parse a parameter file
        * using `prm`.
        */
index 015847c1b91efa4a772387b1ab464dcf01446130..0a920e06c4ee6469e3515a4554d02812edae12f2 100644 (file)
@@ -370,7 +370,7 @@ namespace SUNDIALS
        * a parameter file using `prm`. The values of the parameter will be
        * updated whenever the content of `prm` is updated.
        *
-       * Make sure that this class lives longer than `prm`. Undefined behaviour
+       * Make sure that this class lives longer than `prm`. Undefined behavior
        * will occur if you destroy this class, and then parse a parameter file
        * using `prm`.
        */
index 14a8ca6952d3eeb1ae1c880d24be1c1c1c89bd9f..1fa4fb885d626ab606c4b37e6890f1c4a7378dd4 100644 (file)
@@ -312,7 +312,7 @@ namespace SUNDIALS
        * a parameter file using `prm`. The values of the parameter will be
        * updated whenever the content of `prm` is updated.
        *
-       * Make sure that this class lives longer than `prm`. Undefined behaviour
+       * Make sure that this class lives longer than `prm`. Undefined behavior
        * will occur if you destroy this class, and then parse a parameter file
        * using `prm`.
        */
index e46c50f5f92eed1fe8fc394c9ad9c567fce5c4db..53b4a28fc1948bdd483c7cc47727340d3be79924 100644 (file)
@@ -614,7 +614,7 @@ namespace TrilinosWrappers
 #  ifdef DEBUG
 #    ifdef DEAL_II_WITH_MPI
       // check that every process has decided to use the same mode. This will
-      // otherwise result in undefined behaviour in the call to
+      // otherwise result in undefined behavior in the call to
       // GlobalAssemble().
       double                double_mode = mode;
       const Epetra_MpiComm *comm_ptr =
index 9ceff18af66c104892adb4fed320b1ebeb6992fe..f927cd728f425b7803b348321d64ce1efac5c384 100644 (file)
@@ -816,7 +816,7 @@ TimeStepBase_Tria<dim>::refine_grid(const RefinementData refinement_data)
   // refinement; in this case it often
   // happens that the number of cells
   // does not grow between sweeps, which
-  // clearly is not the wanted behaviour)
+  // clearly is not the wanted behavior)
   //
   // however, if we do not do anything, we
   // can get into trouble somewhen later.
index 4801d9e6ce9e2e09c3a6e3a1e219e7dad0608d54..0739671f85787b8ee3adb092055916fcfef66770 100644 (file)
@@ -22,7 +22,7 @@
 
 //
 // Test GeometryInfo<dim>::face_to_cell_vertices
-// for correct behaviour under face_orientation face_flip and face_rotation
+// for correct behavior under face_orientation face_flip and face_rotation
 //
 
 
index a2a54bf2c07de6854b0b180e56b85c219800e5e5..dda0e928d2461b6178c120b2a0f2eef7d5202f1a 100644 (file)
@@ -43,7 +43,7 @@ std::ofstream logfile("output");
 //                                 dealii::AffineConstraints<double> &,
 //                                 const std::vector<bool>  &,
 //                                 bool, bool, bool)
-// for correct behaviour on non standard oriented meshes.
+// for correct behavior on non standard oriented meshes.
 //
 
 
index 3aeab2aa1086669dc00911b27e34d726da29362f..753f9f7b1d1824e0a68b4ad666953eba5519d05c 100644 (file)
@@ -21,7 +21,7 @@
 //                                 dealii::AffineConstraints<double> &,
 //                                 const std::vector<bool>  &,
 //                                 bool, bool, bool)
-// for correct behaviour on non standard oriented meshes.
+// for correct behavior on non standard oriented meshes.
 //
 // a redux of why the 21_b test failed starting in r29525. in essence,
 // what it boils down is that the new code did not implement the
index 902ad180c66f6fe0e3e69ba9aaa9fbb1981a8822..7637876a537d4b47db5761713ee48aa11079ada6 100644 (file)
@@ -21,7 +21,7 @@
 //                                 dealii::AffineConstraints<double> &,
 //                                 const std::vector<bool>  &,
 //                                 bool, bool, bool)
-// for correct behaviour on non standard oriented meshes.
+// for correct behavior on non standard oriented meshes.
 //
 // like _21_b_x but use a Q3 element. For this, the face_flip has a
 // tricky component in that we need not only flip the two vertics of
index 946a7028683d7dd5e60b0b6def4008e5e1c5d03b..dced77de082dd8bd5c25acf5e170ac69fd29d240 100644 (file)
@@ -21,7 +21,7 @@
 //                                 dealii::AffineConstraints<double> &,
 //                                 const std::vector<bool>  &,
 //                                 bool, bool, bool)
-// for correct behaviour on non standard oriented meshes.
+// for correct behavior on non standard oriented meshes.
 //
 // like _21_b_x, but with a once refined mesh
 
index 3836a076ca7f5b34e2ae9f5f4f46f93bd15baebb..620e3e183d2a6b1d576de9e32e920c0c973d5995 100644 (file)
@@ -44,7 +44,7 @@ std::ofstream logfile("output");
 //                                 const std::vector<bool>  &,
 //                                 bool, bool, bool)
 //
-// for correct behaviour with hanging nodes. This is done by additionally
+// for correct behavior with hanging nodes. This is done by additionally
 // refining the second cube once. Test that constraining face_1 -> face_2
 // and the opposite direction face_2 -> face_1 give the exact same result.
 //
index be5d1cec276f1df82a53e210262905e7a112e559..14eff7cf2b5d7fa3144aa19830ee4daeb87d827f 100644 (file)
@@ -15,7 +15,7 @@
 //
 // This test was written by Sam Cox.
 
-// Tests the behaviour of DoFTools::make_flux_sparsity_pattern (DoFHandler,
+// Tests the behavior of DoFTools::make_flux_sparsity_pattern (DoFHandler,
 //                          SparsityPattern, AffineConstraints<double>, bool,
 //                          coupling, flux_coupling, subdomain_id)
 
index 1f13187e9d293f111abaefb492d67042063297ed..c643b12a0c6d72073c4e1951ccbef682d8189dce 100644 (file)
@@ -83,7 +83,7 @@ test()
 
   deallog << "full h&p flags" << std::endl;
   {
-    deallog << " default behaviour: ";
+    deallog << " default behavior: ";
     {
       Triangulation<dim>  tria;
       hp::DoFHandler<dim> dh;
@@ -122,7 +122,7 @@ test()
 
   deallog << "full p flags" << std::endl;
   {
-    deallog << " default behaviour: ";
+    deallog << " default behavior: ";
     {
       Triangulation<dim>  tria;
       hp::DoFHandler<dim> dh;
@@ -164,7 +164,7 @@ test()
 
   deallog << "full h flags" << std::endl;
   {
-    deallog << " default behaviour: ";
+    deallog << " default behavior: ";
     {
       Triangulation<dim>  tria;
       hp::DoFHandler<dim> dh;
index 1425a6504b6bd6051b4f6dfa332f7ef96f77ec18..e4bb5e61f6bac4e1f0d92885d05caac3007d5a0a 100644 (file)
@@ -1,43 +1,43 @@
 
 DEAL:1d::starting situation: ncells: 2 fe_indices: 0 0
 DEAL:1d::full h&p flags
-DEAL:1d:: default behaviour: ncells: 1 fe_indices: 1
+DEAL:1d:: default behavior: ncells: 1 fe_indices: 1
 DEAL:1d:: force p over h   : ncells: 2 fe_indices: 1 1
 DEAL:1d:: choose p over h  : ncells: 2 fe_indices: 1 1
 DEAL:1d::full p flags
-DEAL:1d:: default behaviour: ncells: 2 fe_indices: 1 1
+DEAL:1d:: default behavior: ncells: 2 fe_indices: 1 1
 DEAL:1d:: force p over h   : ncells: 2 fe_indices: 1 1
 DEAL:1d:: choose p over h  : ncells: 2 fe_indices: 1 1
 DEAL:1d::full h flags
-DEAL:1d:: default behaviour: ncells: 1 fe_indices: 1
+DEAL:1d:: default behavior: ncells: 1 fe_indices: 1
 DEAL:1d:: force p over h   : ncells: 2 fe_indices: 0 1
 DEAL:1d:: choose p over h  : ncells: 1 fe_indices: 0
 DEAL:1d::OK
 DEAL:2d::starting situation: ncells: 4 fe_indices: 0 0 0 0
 DEAL:2d::full h&p flags
-DEAL:2d:: default behaviour: ncells: 1 fe_indices: 1
+DEAL:2d:: default behavior: ncells: 1 fe_indices: 1
 DEAL:2d:: force p over h   : ncells: 4 fe_indices: 1 1 1 1
 DEAL:2d:: choose p over h  : ncells: 4 fe_indices: 1 1 1 1
 DEAL:2d::full p flags
-DEAL:2d:: default behaviour: ncells: 4 fe_indices: 1 1 1 1
+DEAL:2d:: default behavior: ncells: 4 fe_indices: 1 1 1 1
 DEAL:2d:: force p over h   : ncells: 4 fe_indices: 1 1 1 1
 DEAL:2d:: choose p over h  : ncells: 4 fe_indices: 1 1 1 1
 DEAL:2d::full h flags
-DEAL:2d:: default behaviour: ncells: 1 fe_indices: 1
+DEAL:2d:: default behavior: ncells: 1 fe_indices: 1
 DEAL:2d:: force p over h   : ncells: 4 fe_indices: 0 1 1 1
 DEAL:2d:: choose p over h  : ncells: 1 fe_indices: 0
 DEAL:2d::OK
 DEAL:3d::starting situation: ncells: 8 fe_indices: 0 0 0 0 0 0 0 0
 DEAL:3d::full h&p flags
-DEAL:3d:: default behaviour: ncells: 1 fe_indices: 1
+DEAL:3d:: default behavior: ncells: 1 fe_indices: 1
 DEAL:3d:: force p over h   : ncells: 8 fe_indices: 1 1 1 1 1 1 1 1
 DEAL:3d:: choose p over h  : ncells: 8 fe_indices: 1 1 1 1 1 1 1 1
 DEAL:3d::full p flags
-DEAL:3d:: default behaviour: ncells: 8 fe_indices: 1 1 1 1 1 1 1 1
+DEAL:3d:: default behavior: ncells: 8 fe_indices: 1 1 1 1 1 1 1 1
 DEAL:3d:: force p over h   : ncells: 8 fe_indices: 1 1 1 1 1 1 1 1
 DEAL:3d:: choose p over h  : ncells: 8 fe_indices: 1 1 1 1 1 1 1 1
 DEAL:3d::full h flags
-DEAL:3d:: default behaviour: ncells: 1 fe_indices: 1
+DEAL:3d:: default behavior: ncells: 1 fe_indices: 1
 DEAL:3d:: force p over h   : ncells: 8 fe_indices: 0 1 1 1 1 1 1 1
 DEAL:3d:: choose p over h  : ncells: 1 fe_indices: 0
 DEAL:3d::OK
index a1e32f9a33041a2a4f89976b0de0d4561968db3e..e670e26335cf89b9736fab18b8e5bdaa94fbe575 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check correct behaviour of Trilinos ghosted vectors
+// check correct behavior of Trilinos ghosted vectors
 // create distributed and copy into ghosted...
 
 #include <deal.II/base/index_set.h>
index 95895d02bc83f6d1b41a95b3ebc26ab7d1c7db65..10e47652a1169bd37ce9db4debc4d00252f9475e 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check correct behaviour of Trilinos ghosted vectors
+// check correct behavior of Trilinos ghosted vectors
 
 #include <deal.II/base/index_set.h>
 #include <deal.II/base/utilities.h>
index 342e94ae51ab87b2cae1f87aa6158028fc221293..14ae87eca1555b504541f2f90fdb5d73bf873667 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check correct behaviour of Trilinos ghosted vectors.  The
+// check correct behavior of Trilinos ghosted vectors.  The
 // test now checks that v.l2_norm() and v(idx)=... is disabled.
 
 #include <deal.II/base/index_set.h>
index b799062cb13ad06b0e4ffcaa43b86a065d783f09..cc4a64e97837cfa9c28143bbf5dbee99e7346dc9 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check correct behaviour of Trilinos ghosted vectors
+// check correct behavior of Trilinos ghosted vectors
 // check if assignment from a normal vector works correctly and updates the
 // ghost values
 
index 09076c22e0b28c1d070803faf3461ba89d38f909..a9ab4f0619d1f122ad828eafdfb1b32eac7f7714 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check correct behaviour of reinit of Trilinos vectors
+// check correct behavior of reinit of Trilinos vectors
 
 #include <deal.II/base/index_set.h>
 #include <deal.II/base/utilities.h>

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.