+++ /dev/null
-// ------------------------------------------------------------------------
-//
-// 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
#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
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
#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>
+++ /dev/null
-// ------------------------------------------------------------------------
-//
-// 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