From: Wolfgang Bangerth Date: Wed, 21 Oct 2020 22:30:37 +0000 (-0600) Subject: Use American English. X-Git-Tag: v9.3.0-rc1~987^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F11077%2Fhead;p=dealii.git Use American English. --- diff --git a/examples/step-44/doc/intro.dox b/examples/step-44/doc/intro.dox index bb8946b3d7..c86b0ee7d8 100644 --- a/examples/step-44/doc/intro.dox +++ b/examples/step-44/doc/intro.dox @@ -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. diff --git a/examples/step-44/step-44.cc b/examples/step-44/step-44.cc index dcd39426eb..0c14459b36 100644 --- a/examples/step-44/step-44.cc +++ b/examples/step-44/step-44.cc @@ -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}) diff --git a/include/deal.II/base/parameter_acceptor.h b/include/deal.II/base/parameter_acceptor.h index b0204672ad..79693c1f9b 100644 --- a/include/deal.II/base/parameter_acceptor.h +++ b/include/deal.II/base/parameter_acceptor.h @@ -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: diff --git a/include/deal.II/base/symbolic_function.h b/include/deal.II/base/symbolic_function.h index c207c46eeb..42a7a3c14d 100644 --- a/include/deal.II/base/symbolic_function.h +++ b/include/deal.II/base/symbolic_function.h @@ -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 diff --git a/include/deal.II/base/tensor_function.h b/include/deal.II/base/tensor_function.h index a194b135fc..33457c7c9b 100644 --- a/include/deal.II/base/tensor_function.h +++ b/include/deal.II/base/tensor_function.h @@ -39,7 +39,7 @@ DEAL_II_NAMESPACE_OPEN * the Function class, one can ask for a specific component only, or * use the vector_value 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 diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 814fefbd35..18e42e92ab 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -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, diff --git a/include/deal.II/grid/filtered_iterator.h b/include/deal.II/grid/filtered_iterator.h index d77958f48a..40b4aa5e4b 100644 --- a/include/deal.II/grid/filtered_iterator.h +++ b/include/deal.II/grid/filtered_iterator.h @@ -437,7 +437,7 @@ namespace IteratorFilters *

Initialization of filtered iterators

* * 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 diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index d053321949..2252955399 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -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: * *

diff --git a/include/deal.II/hp/fe_collection.h b/include/deal.II/hp/fe_collection.h index 5c319f378b..7ef70c7e4e 100644 --- a/include/deal.II/hp/fe_collection.h +++ b/include/deal.II/hp/fe_collection.h @@ -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 diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index 05d3c61f19..4b97046f8b 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -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 diff --git a/include/deal.II/lac/schur_complement.h b/include/deal.II/lac/schur_complement.h index e7b58ae7a4..ad636a7ef2 100644 --- a/include/deal.II/lac/schur_complement.h +++ b/include/deal.II/lac/schur_complement.h @@ -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 tests/lac/schur_complement_01.cc . The solution of a multi- diff --git a/include/deal.II/lac/slepc_solver.h b/include/deal.II/lac/slepc_solver.h index a367d60ada..7ec979b662 100644 --- a/include/deal.II/lac/slepc_solver.h +++ b/include/deal.II/lac/slepc_solver.h @@ -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, diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index 050fcb7a9b..99171c9bfe 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -274,7 +274,7 @@ public: * waste some memory, so keep this in mind. However, if N==0 all * memory is freed, i.e. if you want to resize the vector and release the * memory not needed, you have to first call reinit(0) and then - * reinit(N). This cited behaviour is analogous to that of the + * reinit(N). 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. diff --git a/include/deal.II/numerics/time_dependent.h b/include/deal.II/numerics/time_dependent.h index 8808c0b882..db1161ed54 100644 --- a/include/deal.II/numerics/time_dependent.h +++ b/include/deal.II/numerics/time_dependent.h @@ -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 @@ -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, TimeStepBase_Tria> tria; diff --git a/include/deal.II/sundials/arkode.h b/include/deal.II/sundials/arkode.h index c327ff5249..a2e76105b4 100644 --- a/include/deal.II/sundials/arkode.h +++ b/include/deal.II/sundials/arkode.h @@ -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`. */ diff --git a/include/deal.II/sundials/ida.h b/include/deal.II/sundials/ida.h index 015847c1b9..0a920e06c4 100644 --- a/include/deal.II/sundials/ida.h +++ b/include/deal.II/sundials/ida.h @@ -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`. */ diff --git a/include/deal.II/sundials/kinsol.h b/include/deal.II/sundials/kinsol.h index 14a8ca6952..1fa4fb885d 100644 --- a/include/deal.II/sundials/kinsol.h +++ b/include/deal.II/sundials/kinsol.h @@ -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`. */ diff --git a/source/lac/trilinos_vector.cc b/source/lac/trilinos_vector.cc index e46c50f5f9..53b4a28fc1 100644 --- a/source/lac/trilinos_vector.cc +++ b/source/lac/trilinos_vector.cc @@ -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 = diff --git a/source/numerics/time_dependent.cc b/source/numerics/time_dependent.cc index 9ceff18af6..f927cd728f 100644 --- a/source/numerics/time_dependent.cc +++ b/source/numerics/time_dependent.cc @@ -816,7 +816,7 @@ TimeStepBase_Tria::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. diff --git a/tests/base/geometry_info_8.cc b/tests/base/geometry_info_8.cc index 4801d9e6ce..0739671f85 100644 --- a/tests/base/geometry_info_8.cc +++ b/tests/base/geometry_info_8.cc @@ -22,7 +22,7 @@ // // Test GeometryInfo::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 // diff --git a/tests/dofs/dof_tools_21_b.cc b/tests/dofs/dof_tools_21_b.cc index a2a54bf2c0..dda0e928d2 100644 --- a/tests/dofs/dof_tools_21_b.cc +++ b/tests/dofs/dof_tools_21_b.cc @@ -43,7 +43,7 @@ std::ofstream logfile("output"); // dealii::AffineConstraints &, // const std::vector &, // bool, bool, bool) -// for correct behaviour on non standard oriented meshes. +// for correct behavior on non standard oriented meshes. // diff --git a/tests/dofs/dof_tools_21_b_x.cc b/tests/dofs/dof_tools_21_b_x.cc index 3aeab2aa10..753f9f7b1d 100644 --- a/tests/dofs/dof_tools_21_b_x.cc +++ b/tests/dofs/dof_tools_21_b_x.cc @@ -21,7 +21,7 @@ // dealii::AffineConstraints &, // const std::vector &, // 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 diff --git a/tests/dofs/dof_tools_21_b_x_q3.cc b/tests/dofs/dof_tools_21_b_x_q3.cc index 902ad180c6..7637876a53 100644 --- a/tests/dofs/dof_tools_21_b_x_q3.cc +++ b/tests/dofs/dof_tools_21_b_x_q3.cc @@ -21,7 +21,7 @@ // dealii::AffineConstraints &, // const std::vector &, // 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 diff --git a/tests/dofs/dof_tools_21_b_y.cc b/tests/dofs/dof_tools_21_b_y.cc index 946a702868..dced77de08 100644 --- a/tests/dofs/dof_tools_21_b_y.cc +++ b/tests/dofs/dof_tools_21_b_y.cc @@ -21,7 +21,7 @@ // dealii::AffineConstraints &, // const std::vector &, // 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 diff --git a/tests/dofs/dof_tools_21_c.cc b/tests/dofs/dof_tools_21_c.cc index 3836a076ca..620e3e183d 100644 --- a/tests/dofs/dof_tools_21_c.cc +++ b/tests/dofs/dof_tools_21_c.cc @@ -44,7 +44,7 @@ std::ofstream logfile("output"); // const std::vector &, // 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. // diff --git a/tests/dofs/dof_tools_22a.cc b/tests/dofs/dof_tools_22a.cc index be5d1cec27..14eff7cf2b 100644 --- a/tests/dofs/dof_tools_22a.cc +++ b/tests/dofs/dof_tools_22a.cc @@ -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, bool, // coupling, flux_coupling, subdomain_id) diff --git a/tests/hp/hp_coarsening.cc b/tests/hp/hp_coarsening.cc index 1f13187e9d..c643b12a0c 100644 --- a/tests/hp/hp_coarsening.cc +++ b/tests/hp/hp_coarsening.cc @@ -83,7 +83,7 @@ test() deallog << "full h&p flags" << std::endl; { - deallog << " default behaviour: "; + deallog << " default behavior: "; { Triangulation tria; hp::DoFHandler dh; @@ -122,7 +122,7 @@ test() deallog << "full p flags" << std::endl; { - deallog << " default behaviour: "; + deallog << " default behavior: "; { Triangulation tria; hp::DoFHandler dh; @@ -164,7 +164,7 @@ test() deallog << "full h flags" << std::endl; { - deallog << " default behaviour: "; + deallog << " default behavior: "; { Triangulation tria; hp::DoFHandler dh; diff --git a/tests/hp/hp_coarsening.output b/tests/hp/hp_coarsening.output index 1425a6504b..e4bb5e61f6 100644 --- a/tests/hp/hp_coarsening.output +++ b/tests/hp/hp_coarsening.output @@ -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 diff --git a/tests/mpi/trilinos_ghost_01.cc b/tests/mpi/trilinos_ghost_01.cc index a1e32f9a33..e670e26335 100644 --- a/tests/mpi/trilinos_ghost_01.cc +++ b/tests/mpi/trilinos_ghost_01.cc @@ -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 diff --git a/tests/mpi/trilinos_ghost_02.cc b/tests/mpi/trilinos_ghost_02.cc index 95895d02bc..10e47652a1 100644 --- a/tests/mpi/trilinos_ghost_02.cc +++ b/tests/mpi/trilinos_ghost_02.cc @@ -15,7 +15,7 @@ -// check correct behaviour of Trilinos ghosted vectors +// check correct behavior of Trilinos ghosted vectors #include #include diff --git a/tests/mpi/trilinos_ghost_03.cc b/tests/mpi/trilinos_ghost_03.cc index 342e94ae51..14ae87eca1 100644 --- a/tests/mpi/trilinos_ghost_03.cc +++ b/tests/mpi/trilinos_ghost_03.cc @@ -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 diff --git a/tests/mpi/trilinos_ghost_05.cc b/tests/mpi/trilinos_ghost_05.cc index b799062cb1..cc4a64e978 100644 --- a/tests/mpi/trilinos_ghost_05.cc +++ b/tests/mpi/trilinos_ghost_05.cc @@ -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 diff --git a/tests/mpi/trilinos_vector_reinit.cc b/tests/mpi/trilinos_vector_reinit.cc index 09076c22e0..a9ab4f0619 100644 --- a/tests/mpi/trilinos_vector_reinit.cc +++ b/tests/mpi/trilinos_vector_reinit.cc @@ -15,7 +15,7 @@ -// check correct behaviour of reinit of Trilinos vectors +// check correct behavior of reinit of Trilinos vectors #include #include