]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename zero_out_ghosts to zero_out_ghost_values 11461/head
authorPeter Munch <peterrmuench@gmail.com>
Mon, 4 Jan 2021 11:50:02 +0000 (12:50 +0100)
committerPeter Munch <peterrmuench@gmail.com>
Wed, 20 Jan 2021 10:14:22 +0000 (11:14 +0100)
29 files changed:
doc/news/changes/incompatibilities/20210104Munch [new file with mode: 0644]
examples/step-48/step-48.cc
examples/step-67/step-67.cc
examples/step-68/step-68.cc
include/deal.II/distributed/solution_transfer.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_block_vector.templates.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/matrix_free/cuda_matrix_free.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
source/multigrid/mg_transfer_matrix_free.cc
tests/cuda/parallel_vector_15.cu
tests/cuda/parallel_vector_16.cu
tests/cuda/parallel_vector_22.cu
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_04.cc
tests/matrix_free/compare_faces_by_cells.cc
tests/matrix_free/loop_boundary.cc
tests/matrix_free/multigrid_dg_sip_01.cc
tests/matrix_free/multigrid_dg_sip_02.cc
tests/mpi/parallel_block_vector_02.cc
tests/mpi/parallel_block_vector_13.cc
tests/mpi/parallel_vector_15.cc
tests/mpi/parallel_vector_16.cc
tests/mpi/parallel_vector_22.cc
tests/numerics/project_parallel_common.h

diff --git a/doc/news/changes/incompatibilities/20210104Munch b/doc/news/changes/incompatibilities/20210104Munch
new file mode 100644 (file)
index 0000000..a32d5f1
--- /dev/null
@@ -0,0 +1,4 @@
+Deprecated: All `LinearAlgebra::distributed::Vector::zero_out_ghosts()` has been deprecated. 
+Use `LinearAlgebra::distributed::Vector::zero_out_ghost_values()` instead.
+<br>
+(Peter Munch, 2021/01/04)
index 7d455339a1ca3fec817150e012cf94a31df0fa40..76b98f88d38e55270b392180a8d556edb6c18973 100644 (file)
@@ -508,7 +508,7 @@ namespace Step48
     data_out.write_vtu_with_pvtu_record(
       "./", "solution", timestep_number, MPI_COMM_WORLD, 3);
 
-    solution.zero_out_ghosts();
+    solution.zero_out_ghost_values();
   }
 
 
index 9186562b23c2d3487c9f7fcb9a4a84e4e7eb6b8a..d940ed1f2fcf2d0dd2a571136453359b3dd32e81 100644 (file)
@@ -1544,7 +1544,7 @@ namespace Euler_DG
     FEEvaluation<dim, degree, degree + 1, dim + 2, Number> phi(data, 0, 1);
     MatrixFreeOperators::CellwiseInverseMassMatrix<dim, degree, dim + 2, Number>
       inverse(phi);
-    solution.zero_out_ghosts();
+    solution.zero_out_ghost_values();
     for (unsigned int cell = 0; cell < data.n_cell_batches(); ++cell)
       {
         phi.reinit(cell);
index 1d0abc52b243cbae9bb6bc32c6c0cf1259289dab..717d137ec088c1dda3c1c8d53c31fe9527c3e455 100644 (file)
@@ -502,7 +502,7 @@ namespace Step68
   template <int dim>
   void ParticleTracking<dim>::interpolate_function_to_field()
   {
-    velocity_field.zero_out_ghosts();
+    velocity_field.zero_out_ghost_values();
     VectorTools::interpolate(mapping, fluid_dh, velocity, velocity_field);
     velocity_field.update_ghost_values();
   }
index 23d0c8084ca75128e4999ede62ec318f96dae992..48c272c4facf5eb33183ed97733526c9c53fc978 100644 (file)
@@ -120,7 +120,7 @@ namespace parallel
      * LinearAlgebra::distributed::Vector allows writing into ghost elements.
      * For a ghosted vector the interpolation step can be accomplished via
      * @code
-     * interpolated_solution.zero_out_ghosts();
+     * interpolated_solution.zero_out_ghost_values();
      * soltrans.interpolate(interpolated_solution);
      * interpolated_solution.update_ghost_values();
      * @endcode
index 4d0c728c8cd26d0a9d8942e6baadf37140a0a29a..23e21fb6226e76a25d3d26be7d5d2d26bed5242d 100644 (file)
@@ -1885,7 +1885,7 @@ namespace internal
           if (vec.in_local_range(idx))
             vec(idx) = 0.;
         }
-      vec.zero_out_ghosts();
+      vec.zero_out_ghost_values();
     }
 
 #ifdef DEAL_II_COMPILER_CUDA_AWARE
@@ -1930,7 +1930,7 @@ namespace internal
 
       Utilities::CUDA::free(constrained_local_dofs_device);
 
-      vec.zero_out_ghosts();
+      vec.zero_out_ghost_values();
     }
 #endif
 
@@ -2174,7 +2174,7 @@ namespace internal
     // TODO: the in vector might already have all elements. need to find a
     // way to efficiently avoid the copy then
     const_cast<LinearAlgebra::distributed::Vector<number> &>(vec)
-      .zero_out_ghosts();
+      .zero_out_ghost_values();
     output.reinit(locally_owned_elements,
                   needed_elements,
                   vec.get_mpi_communicator());
index 419614e3951cbac0e4b38d64439fb4d4d83241c6..9ededf222c703f6eea2b44839ea80d7e37a3f618 100644 (file)
@@ -348,10 +348,24 @@ namespace LinearAlgebra
        * After calling this method, read access to ghost elements of the
        * vector is forbidden and an exception is thrown. Only write access to
        * ghost elements is allowed in this state.
+       *
+       * @deprecated Use zero_out_ghost_values() instead.
        */
-      void
+      DEAL_II_DEPRECATED_EARLY void
       zero_out_ghosts() const;
 
+
+      /**
+       * This method zeros the entries on ghost dofs, but does not touch
+       * locally owned DoFs.
+       *
+       * After calling this method, read access to ghost elements of the
+       * vector is forbidden and an exception is thrown. Only write access to
+       * ghost elements is allowed in this state.
+       */
+      void
+      zero_out_ghost_values() const;
+
       /**
        * Return if this Vector contains ghost elements.
        */
index f302158c17271c638667d51f0712af743e5685ed..0274c0aa93a6290de4c688df611e6b1cfd7489d4 100644 (file)
@@ -378,9 +378,18 @@ namespace LinearAlgebra
     template <typename Number>
     void
     BlockVector<Number>::zero_out_ghosts() const
+    {
+      this->zero_out_ghost_values();
+    }
+
+
+
+    template <typename Number>
+    void
+    BlockVector<Number>::zero_out_ghost_values() const
     {
       for (unsigned int block = 0; block < this->n_blocks(); ++block)
-        this->block(block).zero_out_ghosts();
+        this->block(block).zero_out_ghost_values();
     }
 
 
index 90aba609998e65a5fc85511523c839238e8f2ec0..209de68f5c72611e04d4fca61d10de490bf5ce7b 100644 (file)
@@ -134,7 +134,7 @@ namespace LinearAlgebra
      * This vector can take two different states with respect to ghost
      * elements:
      * <ul>
-     * <li> After creation and whenever zero_out_ghosts() is called (or
+     * <li> After creation and whenever zero_out_ghost_values() is called (or
      * <code>operator= (0.)</code>), the vector does only allow writing into
      * ghost elements but not reading from ghost elements.
      * <li> After a call to update_ghost_values(), the vector does not allow
@@ -515,7 +515,7 @@ namespace LinearAlgebra
        * operation. However, global reduction operations like norms or the
        * inner product will always ignore ghost elements in order to avoid
        * counting the ghost data more than once. To allow writing to ghost
-       * elements again, call zero_out_ghosts().
+       * elements again, call zero_out_ghost_values().
        *
        * @see
        * @ref GlossGhostedVector "vectors with ghost elements"
@@ -605,10 +605,23 @@ namespace LinearAlgebra
        * After calling this method, read access to ghost elements of the
        * vector is forbidden and an exception is thrown. Only write access to
        * ghost elements is allowed in this state.
+       *
+       * @deprecated Use zero_out_ghost_values() instead.
        */
-      void
+      DEAL_II_DEPRECATED_EARLY void
       zero_out_ghosts() const;
 
+      /**
+       * This method zeros the entries on ghost dofs, but does not touch
+       * locally owned DoFs.
+       *
+       * After calling this method, read access to ghost elements of the
+       * vector is forbidden and an exception is thrown. Only write access to
+       * ghost elements is allowed in this state.
+       */
+      void
+      zero_out_ghost_values() const;
+
       /**
        * Return whether the vector currently is in a state where ghost values
        * can be read or not. This is the same functionality as other parallel
index 2c5a8fc4994591fdf2ed5db5a451c1678a8783f6..28c433026512de14b238c873b8117bf590594657 100644 (file)
@@ -537,7 +537,7 @@ namespace LinearAlgebra
       if (omit_zeroing_entries == false)
         this->operator=(Number());
       else
-        zero_out_ghosts();
+        zero_out_ghost_values();
     }
 
 
@@ -598,7 +598,7 @@ namespace LinearAlgebra
       if (omit_zeroing_entries == false)
         this->operator=(Number());
       else
-        zero_out_ghosts();
+        zero_out_ghost_values();
 
       // do not reallocate import_data directly, but only upon request. It
       // is only used as temporary storage for compress() and
@@ -846,7 +846,7 @@ namespace LinearAlgebra
       if (must_update_ghost_values)
         update_ghost_values();
       else
-        zero_out_ghosts();
+        zero_out_ghost_values();
       return *this;
     }
 
@@ -916,6 +916,15 @@ namespace LinearAlgebra
     template <typename Number, typename MemorySpaceType>
     void
     Vector<Number, MemorySpaceType>::zero_out_ghosts() const
+    {
+      this->zero_out_ghost_values();
+    }
+
+
+
+    template <typename Number, typename MemorySpaceType>
+    void
+    Vector<Number, MemorySpaceType>::zero_out_ghost_values() const
     {
       if (data.values != nullptr)
         std::fill_n(data.values.get() + partitioner->local_size(),
@@ -1420,7 +1429,7 @@ namespace LinearAlgebra
       // if we call Vector::operator=0, we want to zero out all the entries
       // plus ghosts.
       if (s == Number())
-        zero_out_ghosts();
+        zero_out_ghost_values();
 
       return *this;
     }
index af8904b1d1baf522798352c21586ea7593ae80d5..b2b8bc70c2d08df95e252ee07e5e991e377fd4d6 100644 (file)
@@ -1218,7 +1218,7 @@ namespace CUDAWrappers
                 }
             dst.compress(VectorOperation::add);
           }
-        src.zero_out_ghosts();
+        src.zero_out_ghost_values();
       }
     else
       {
index 85ed911cd3b21f5da1b3ad0841116a434429d585..6e407a20530c35e2504cbf793b98d8d03f8244f7 100644 (file)
@@ -3797,7 +3797,7 @@ namespace internal
       if (ghosts_were_set == true)
         return;
 
-      vec.zero_out_ghosts();
+      vec.zero_out_ghost_values();
     }
 
 
index d71c60623cc2abf42857f3968ac729dd34027704..87eb8ee0f7c35fd60d226fba03ce9898b1310f94 100644 (file)
@@ -531,7 +531,7 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number>>::copy_from_mg(
       // In this case, we can simply copy the local range. To avoid having
       // stray data in ghost entries of the destination, make sure to clear
       // them here.
-      dst.zero_out_ghosts();
+      dst.zero_out_ghost_values();
       AssertDimension(src[src.max_level()].local_size(), dst.local_size());
       dst.copy_locally_owned_data_from(src[src.max_level()]);
       return;
@@ -544,7 +544,7 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number>>::copy_from_mg(
       Assert(copy_indices_global_mine.back().empty(), ExcInternalError());
       const LinearAlgebra::distributed::Vector<Number> &src_level =
         src[src.max_level()];
-      dst.zero_out_ghosts();
+      dst.zero_out_ghost_values();
       for (unsigned int i = 0; i < copy_indices.back().n_cols(); ++i)
         dst.local_element(i) =
           src_level.local_element(copy_indices.back()(1, i));
@@ -602,7 +602,7 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number>>::
   // attention, since they belong to the coarse level, but have fine level
   // basis functions
 
-  dst.zero_out_ghosts();
+  dst.zero_out_ghost_values();
   for (unsigned int level = src.min_level(); level <= src.max_level(); ++level)
     {
       // the ghosted vector should already have the correct local size (but
index 4985e280006d9c21ea249b5263837e9c18d14e72..f5cad203d890e74ebb60b3886710fb5a439c54ab 100644 (file)
@@ -1742,8 +1742,8 @@ MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>>::prolongate(
         }
     }
 
-  this->vec_coarse.zero_out_ghosts(); // clear ghost values; else compress in
-                                      // do_restrict_add does not work
+  this->vec_coarse.zero_out_ghost_values(); // clear ghost values; else compress
+                                            // in do_restrict_add does not work
 
   if (schemes.size() > 0 && schemes.front().fine_element_is_continuous)
     this->vec_fine.compress(VectorOperation::add);
index f68c62a40bff0eb98c9fc5c9d5d1337c542b15a6..6da035520ed07633743548a2120d0263ed80d5c7 100644 (file)
@@ -253,7 +253,7 @@ MGTransferMatrixFree<dim, Number>::prolongate(
     dst.copy_locally_owned_data_from(this->ghosted_level_vector[to_level]);
 
   if (src_inplace == true)
-    src.zero_out_ghosts();
+    src.zero_out_ghost_values();
 }
 
 
@@ -330,7 +330,7 @@ MGTransferMatrixFree<dim, Number>::restrict_and_add(
     dst += dst_vec;
 
   if (src_inplace == true)
-    src.zero_out_ghosts();
+    src.zero_out_ghost_values();
 }
 
 
index 3a77b32fb921ca00f577cb56c8aa278a20d4cf85..050c320fedf489e4390c06341505db575470b5c8 100644 (file)
@@ -77,12 +77,12 @@ test()
   if (myid == 0)
     deallog << "w has ghost elements: " << w.has_ghost_elements() << std::endl;
 
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   w = v;
   if (myid == 0)
     deallog << "w has ghost elements: " << w.has_ghost_elements() << std::endl;
 
-  w.zero_out_ghosts();
+  w.zero_out_ghost_values();
   w = v;
   if (myid == 0)
     deallog << "w has ghost elements: " << w.has_ghost_elements() << std::endl;
@@ -92,7 +92,7 @@ test()
   if (myid == 0)
     deallog << "x has ghost elements: " << x.has_ghost_elements() << std::endl;
 
-  x.zero_out_ghosts();
+  x.zero_out_ghost_values();
   if (myid == 0)
     deallog << "x has ghost elements: " << x.has_ghost_elements() << std::endl;
 
index d310e0e134dd58fc8c2e2689386892d6da137151..68e71da7662fcca71d70be2062a81094c9d4dcd7 100644 (file)
@@ -78,7 +78,7 @@ test()
   v.update_ghost_values();
   v.print(deallog.get_file_stream(), 12, false, false);
 
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   double *    values_dev  = v.get_values();
   const auto &partitioner = v.get_partitioner();
   set_value<<<1, 1>>>(values_dev,
index 22cd2d16227cbd500fd295a748227a7b0056d6ce..6456af6e9b6fbf96175d13701bd3a2c16d0ec4e4 100644 (file)
@@ -106,7 +106,7 @@ test()
           << std::endl;
 
   // ghosts are set to zero
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
 
   // minimize
   v.compress(VectorOperation::min);
@@ -119,7 +119,7 @@ test()
           << std::endl;
 
   // set ghost dof on non-owning processors and minimize
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   if (myid == 0)
     set_value<<<1, 1>>>(v.get_values(), partitioner->global_to_local(1), -1.);
   v.compress(VectorOperation::min);
@@ -132,7 +132,7 @@ test()
           << std::endl;
 
   // set vector to 1, zeros in ghosts except on owner where -1. is set
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   v = 1.0;
   if (myid == 0)
     set_value<<<1, 1>>>(v.get_values(), partitioner->global_to_local(1), -1.);
@@ -150,7 +150,7 @@ test()
 
   // however, if the ghost value is set on all processors, the
   // maximum is -1:
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   v = 1.0;
   set_value<<<1, 1>>>(v.get_values(), partitioner->global_to_local(1), -1.);
   v.compress(VectorOperation::max);
@@ -162,7 +162,7 @@ test()
 
   // what happens in case max is called two times and all values were smaller
   // than zero
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   v = -1.0;
   set_value<<<1, 1>>>(v.get_values(), partitioner->global_to_local(1), -1.);
   v.compress(VectorOperation::max);
index e32f9970c2f5e6da470048cef7f8f99ea26263cc..aeb41bb11fb78bb12e85990b0de2ca19d9c8ffab 100644 (file)
@@ -122,8 +122,8 @@ test()
   sparse_rhs.reinit(locally_owned_set, locally_relevant_set, MPI_COMM_WORLD);
   rhs.reinit(locally_owned_set, locally_relevant_set, MPI_COMM_WORLD);
 
-  sparse_rhs.zero_out_ghosts();
-  rhs.zero_out_ghosts();
+  sparse_rhs.zero_out_ghost_values();
+  rhs.zero_out_ghost_values();
 
   // assemble RHS which has a local support:
   const std::function<double(const Point<dim> &)> rhs_func =
index 5e73b207a6b88799b0fc97a235753290e669f529..5e200c5991e9429a6b38d32c5c92ada2bdfb3656 100644 (file)
@@ -97,7 +97,7 @@ public:
     LinearAlgebra::distributed::Vector<number> &result) const
   {
     int dummy;
-    result.zero_out_ghosts();
+    result.zero_out_ghost_values();
     data.cell_loop(&LaplaceOperator::local_diagonal_by_cell,
                    this,
                    result,
index 4d0b79f4028218c71bc271f4749c62e2c7c68255..96de43a88037bf261a07a19229031740278f3c1c 100644 (file)
@@ -133,7 +133,7 @@ do_test(const unsigned int n_refine, const bool overlap_communication)
                                matrix_free.n_inner_face_batches() +
                                  matrix_free.n_boundary_face_batches()));
   ref.compress(VectorOperation::add);
-  in.zero_out_ghosts();
+  in.zero_out_ghost_values();
 
   std::function<void(const MatrixFree<dim> &,
                      LinearAlgebra::distributed::Vector<double> &,
@@ -209,7 +209,7 @@ do_test(const unsigned int n_refine, const bool overlap_communication)
             in,
             std::make_pair(0U, matrix_free.n_cell_batches()));
   ref.compress(VectorOperation::add);
-  in.zero_out_ghosts();
+  in.zero_out_ghost_values();
 
   matrix_free.cell_loop(cell_func, test, in, true);
   test -= ref;
index be14606d6e798393115638c0d9904132cec6002a..4149a28792c6e2b2fc4874bcf69654deed5ecb15 100644 (file)
@@ -132,7 +132,7 @@ public:
         dst_copy = dst;
         dst.swap(dst_copy);
       }
-    dst.zero_out_ghosts();
+    dst.zero_out_ghost_values();
     data.loop(&LaplaceOperator::local_apply,
               &LaplaceOperator::local_apply_face,
               &LaplaceOperator::local_apply_boundary,
index ba92487280a2b90258654160afc2461a900d187f..7b82ffe11b6e61192ac4622dad365ccc5240d1ac 100644 (file)
@@ -135,7 +135,7 @@ public:
         dst_copy = dst;
         dst.swap(dst_copy);
       }
-    dst.zero_out_ghosts();
+    dst.zero_out_ghost_values();
     data.loop(&LaplaceOperator::local_apply,
               &LaplaceOperator::local_apply_face,
               &LaplaceOperator::local_apply_boundary,
index 5ba078cf3ea18455130987579bf47a524d039479..c348620e84ec59556d27a3958bee4b8007ab609f 100644 (file)
@@ -87,7 +87,7 @@ test()
     AssertDimension(i + 1, (unsigned int)w.block(i)(1));
 
   // zero out ghosts, now all processors except processor 1 should have 0.
-  w.zero_out_ghosts();
+  w.zero_out_ghost_values();
   for (unsigned int i = 0; i < 3; ++i)
     if (myid == 0)
       {
index 8189073102495b7237ca0ebbe30407034330fdff..85f29df70e99aa93f9ad93703ca3c5d6aa0aaf63 100644 (file)
@@ -91,7 +91,7 @@ test()
     AssertDimension(i + 1, (unsigned int)w.block(i)(1));
 
   // zero out ghosts, now all processors except processor 1 should have 0.
-  w.zero_out_ghosts();
+  w.zero_out_ghost_values();
   for (unsigned int i = 0; i < n_blocks; ++i)
     if (myid == 0)
       {
index 57f62c408d92de50d37369f128129fafbb2fcd31..fac44512f98026d2ab399cad66326edee1c483b7 100644 (file)
@@ -75,12 +75,12 @@ test()
   if (myid == 0)
     deallog << "w has ghost elements: " << w.has_ghost_elements() << std::endl;
 
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   w = v;
   if (myid == 0)
     deallog << "w has ghost elements: " << w.has_ghost_elements() << std::endl;
 
-  w.zero_out_ghosts();
+  w.zero_out_ghost_values();
   w = v;
   if (myid == 0)
     deallog << "w has ghost elements: " << w.has_ghost_elements() << std::endl;
@@ -90,7 +90,7 @@ test()
   if (myid == 0)
     deallog << "x has ghost elements: " << x.has_ghost_elements() << std::endl;
 
-  x.zero_out_ghosts();
+  x.zero_out_ghost_values();
   if (myid == 0)
     deallog << "x has ghost elements: " << x.has_ghost_elements() << std::endl;
 
index 1a9748539d391e75d64925fd745c2bfa4233ab97..1bec599120dc962d4b9998b1f55c23b5b3bd2dc0 100644 (file)
@@ -76,7 +76,7 @@ test()
   Assert(v(min_index + 39) == min_index + 39, ExcInternalError());
   Assert(v(min_index + 38) == min_index + 38, ExcInternalError());
 
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   v(min_index + 38) = min_index;
   v(min_index + 39) = min_index * 2;
   v(min_index + 41) = min_index + 7;
index d01784514f48327c5a7f17232d88b0f0bae425c7..daf7bc861cc081c3808d3ea7aab528c6fe5aecfc 100644 (file)
@@ -75,7 +75,7 @@ test()
           << "ghost entry after max from owner: " << v(1) << std::endl;
 
   // ghosts are set to zero
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
 
   // minimize
   v.compress(VectorOperation::min);
@@ -86,7 +86,7 @@ test()
           << "ghost entry after min from zero: " << v(1) << std::endl;
 
   // set ghost dof on non-owning processors and minimize
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   if (!myid)
     v(1) = -1.;
   v.compress(VectorOperation::min);
@@ -97,7 +97,7 @@ test()
           << "ghost entry after min from : " << v(1) << std::endl;
 
   // set vector to 1, zeros in ghosts except on owner where -1. is set
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   v = 1.0;
   if (!myid)
     v(1) = -1.0;
@@ -113,7 +113,7 @@ test()
 
   // however, if the ghost value is set on all processors, the
   // maximum is -1:
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   v    = 1.0;
   v(1) = -1.0;
   v.compress(VectorOperation::max);
@@ -123,7 +123,7 @@ test()
 
   // what happens in case max is called two times and all values were smaller
   // than zero
-  v.zero_out_ghosts();
+  v.zero_out_ghost_values();
   v    = -1.0;
   v(1) = -1.0;
   v.compress(VectorOperation::max);
index c6757ea88a0aa209a25946807af7c76263387279..4a1d83e6be7804dffd7f963a44412f7520e3d682 100644 (file)
@@ -129,7 +129,7 @@ do_project(const parallel::distributed::Triangulation<dim> &triangulation,
   for (unsigned int q = 0; q <= p + 2 - order_difference; ++q)
     {
       // project the function
-      projection.zero_out_ghosts();
+      projection.zero_out_ghost_values();
       VectorTools::project(dof_handler,
                            constraints,
                            QGauss<dim>(p + 2),

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.