]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove mpi_compute_index_owner_internal.h.
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 5 Nov 2024 22:27:03 +0000 (15:27 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 7 Nov 2024 14:47:28 +0000 (07:47 -0700)
include/deal.II/base/mpi_compute_index_owner_internal.h [deleted file]
include/deal.II/base/mpi_noncontiguous_partitioner.h
source/base/CMakeLists.txt
source/base/mpi.cc
source/base/mpi_compute_index_owner_internal.cc [deleted file]

diff --git a/include/deal.II/base/mpi_compute_index_owner_internal.h b/include/deal.II/base/mpi_compute_index_owner_internal.h
deleted file mode 100644 (file)
index 83b0a02..0000000
+++ /dev/null
@@ -1,36 +0,0 @@
-// ------------------------------------------------------------------------
-//
-// SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// Part of the source code is dual licensed under Apache-2.0 WITH
-// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-// governing the source code and code contributions can be found in
-// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-//
-// ------------------------------------------------------------------------
-
-#ifndef dealii_base_mpi_compute_index_owner_internal_h
-#define dealii_base_mpi_compute_index_owner_internal_h
-
-#include <deal.II/base/config.h>
-
-#include <deal.II/base/mpi_consensus_algorithms.h>
-#include <deal.II/base/mpi_stub.h>
-
-DEAL_II_NAMESPACE_OPEN
-
-namespace Utilities
-{
-  namespace MPI
-  {
-    namespace internal
-    {} // namespace internal
-  }    // namespace MPI
-} // namespace Utilities
-
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
index 86cb31467874b615d999c6af0b1bb3fc9214e623..aaaf2942b6da6827efaa7b920a85e15828485542 100644 (file)
@@ -18,9 +18,9 @@
 #include <deal.II/base/config.h>
 
 #include <deal.II/base/communication_pattern_base.h>
-#include <deal.II/base/mpi_compute_index_owner_internal.h>
 #include <deal.II/base/mpi_stub.h>
 
+#include <deal.II/lac/vector_operation.h>
 
 
 DEAL_II_NAMESPACE_OPEN
index 1b40cf626eee4e000db4f7af2f252903ff713351..6fa4cc3f9e17779cad83633449d1d5ad6d9d6919 100644 (file)
@@ -49,7 +49,6 @@ set(_unity_include_src
   hdf5.cc
   kokkos.cc
   mpi.cc
-  mpi_compute_index_owner_internal.cc
   mpi_noncontiguous_partitioner.cc
   mpi_remote_point_evaluation.cc
   mu_parser_internal.cc
index ba1a3b70d82b90f5e850167fd6b0965c0d04f1fe..8717598dd72c11d2743ed9e41347ad64a49217ff 100644 (file)
@@ -17,7 +17,7 @@
 #include <deal.II/base/index_set.h>
 #include <deal.II/base/mpi.h>
 #include <deal.II/base/mpi.templates.h>
-#include <deal.II/base/mpi_compute_index_owner_internal.h>
+#include <deal.II/base/mpi_consensus_algorithms.h>
 #include <deal.II/base/mpi_large_count.h>
 #include <deal.II/base/mpi_tags.h>
 #include <deal.II/base/utilities.h>
diff --git a/source/base/mpi_compute_index_owner_internal.cc b/source/base/mpi_compute_index_owner_internal.cc
deleted file mode 100644 (file)
index da488bd..0000000
+++ /dev/null
@@ -1,38 +0,0 @@
-// ------------------------------------------------------------------------
-//
-// SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// Part of the source code is dual licensed under Apache-2.0 WITH
-// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
-// governing the source code and code contributions can be found in
-// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
-//
-// ------------------------------------------------------------------------
-
-#include <deal.II/base/config.h>
-
-#include <deal.II/base/mpi.h>
-#include <deal.II/base/mpi_compute_index_owner_internal.h>
-
-#include <boost/serialization/utility.hpp>
-
-#include <algorithm>
-
-DEAL_II_NAMESPACE_OPEN
-
-namespace Utilities
-{
-  namespace MPI
-  {
-    namespace internal
-    {
-      namespace ComputeIndexOwner
-      {} // namespace ComputeIndexOwner
-    }    // namespace internal
-  }      // namespace MPI
-} // namespace Utilities
-
-DEAL_II_NAMESPACE_CLOSE

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.