From: Marc Fehling Date: Wed, 26 Jun 2024 11:09:18 +0000 (+0200) Subject: Test AffineConstraints::make_consistent_in_parallel() for hp constraints. X-Git-Tag: v9.6.0-rc1~148^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F17175%2Fhead;p=dealii.git Test AffineConstraints::make_consistent_in_parallel() for hp constraints. --- diff --git a/tests/lac/constraints_make_consistent_in_parallel_02.cc b/tests/lac/constraints_make_consistent_in_parallel_02.cc new file mode 100644 index 0000000000..0bceaa51b7 --- /dev/null +++ b/tests/lac/constraints_make_consistent_in_parallel_02.cc @@ -0,0 +1,173 @@ +// ------------------------------------------------------------------------ +// +// SPDX-License-Identifier: LGPL-2.1-or-later +// Copyright (C) 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. +// +// ------------------------------------------------------------------------ + + +// Test AffineConstraints::make_consistent_in_parallel() for hp constraints. +// +// Scenarios like the following for an integer k>1 +// +---+---+---+ +// |p>0|p>k|p=k| +// |s=0|s=1|s=1| +// +---+---+---+ +// cause problems on process 0 after an exchange on all locally relevant DoFs, +// where +// - p denotes the polynomial degree for a Lagrange element Q_p, and +// - s describes the subdomain id. +// p4est partitions the above mesh as shown for two MPI processes. +// +// For process 0, locally relevant DoFs on the center cell are constrained +// against artificial DoFs on the rightmost cell via hanging node constraints. +// This creates issues when resolving chains of constraints in +// AffineConstraints::close(). +// +// AffineConstraints::make_consistent_in_parallel() also updates the local_lines +// of the corresponding constraints object. As a sanity check, we will also +// build a sparsity pattern based on the these new locally relevant DoFs. + + +#include +#include + +#include + +#include +#include + +#include + +#include + +#include + +#include +#include + +#include + +#include "../tests.h" + +#include "../test_grids.h" + + +template +IndexSet +constrained_lines(const AffineConstraints &constraints, + const types::global_dof_index size) +{ + IndexSet lines_local(size); + for (const auto &line : constraints.get_lines()) + lines_local.add_index(line.index); + return lines_local; +} + + +template +void +test() +{ + const MPI_Comm mpi = MPI_COMM_WORLD; + const unsigned int myid = Utilities::MPI::this_mpi_process(mpi); + + // ----- setup ----- + parallel::distributed::Triangulation tr(mpi); + TestGrids::hyper_line(tr, 3); + + DoFHandler dh(tr); + for (const auto &cell : + dh.active_cell_iterators() | IteratorFilters::LocallyOwnedCell()) + { + if (cell->id().to_string() == "0_0:") + cell->set_active_fe_index(1); + else if (cell->id().to_string() == "1_0:") + cell->set_active_fe_index(1); + else if (cell->id().to_string() == "2_0:") + cell->set_active_fe_index(0); + else + Assert(false, ExcInternalError()); + } + + hp::FECollection fes; + for (unsigned int p = 2; p <= 3; ++p) + fes.push_back(FE_Q(p)); + dh.distribute_dofs(fes); + +#if 0 + // ----- output ----- + // Kept for future debugging attempts. + Vector fe_degrees(tr.n_active_cells()); + for (const auto &cell : + dh.active_cell_iterators() | IteratorFilters::LocallyOwnedCell()) + fe_degrees(cell->active_cell_index()) = cell->get_fe().degree; + + Vector subdomain(tr.n_active_cells()); + for (auto &subd : subdomain) + subd = tr.locally_owned_subdomain(); + + DataOut data_out; + data_out.attach_dof_handler(dh); + data_out.add_data_vector(fe_degrees, "fe_degree"); + data_out.add_data_vector(subdomain, "subdomain"); + data_out.build_patches(); + data_out.write_vtu_in_parallel("output-" + Utilities::to_string(dim) + + "d.vtu", + mpi); +#endif + + // ----- constraints ----- + const auto &owned_dofs = dh.locally_owned_dofs(); + const auto active_dofs = DoFTools::extract_locally_active_dofs(dh); + const auto relevant_dofs = DoFTools::extract_locally_relevant_dofs(dh); + + AffineConstraints ac_base(owned_dofs, relevant_dofs); + + deallog << "make_hanging_node_constraints" << std::endl; + DoFTools::make_hanging_node_constraints(dh, ac_base); + constrained_lines(ac_base, dh.n_dofs()).print(deallog.get_file_stream()); + ac_base.get_local_lines().print(deallog.get_file_stream()); + + auto test_consistent = [&](const IndexSet &dofs_to_check) { + AffineConstraints ac(ac_base); + + ac.make_consistent_in_parallel(owned_dofs, dofs_to_check, mpi); + constrained_lines(ac, dh.n_dofs()).print(deallog.get_file_stream()); + ac.get_local_lines().print(deallog.get_file_stream()); + + ac.close(); + + DynamicSparsityPattern dsp(ac.get_local_lines()); + DoFTools::make_sparsity_pattern(dh, dsp, ac, false, myid); + }; + + deallog << "make_consistent_in_parallel on active dofs" << std::endl; + test_consistent(active_dofs); + deallog << "make_consistent_in_parallel on relevant dofs" << std::endl; + test_consistent(relevant_dofs); + + deallog << "OK" << std::endl; +} + + +int +main(int argc, char **argv) +{ + Utilities::MPI::MPI_InitFinalize mpi(argc, argv, 1); + MPILogInitAll all; + + deallog.push("2d"); + test<2>(); + deallog.pop(); + deallog.push("3d"); + test<3>(); + deallog.pop(); +} diff --git a/tests/lac/constraints_make_consistent_in_parallel_02.with_p4est=true.mpirun=2.output b/tests/lac/constraints_make_consistent_in_parallel_02.with_p4est=true.mpirun=2.output new file mode 100644 index 0000000000..f8a284c7da --- /dev/null +++ b/tests/lac/constraints_make_consistent_in_parallel_02.with_p4est=true.mpirun=2.output @@ -0,0 +1,43 @@ + +DEAL:0:2d::make_hanging_node_constraints +{} +{[0,26], 28} +DEAL:0:2d::make_consistent_in_parallel on active dofs +{} +{[0,26], 28} +DEAL:0:2d::make_consistent_in_parallel on relevant dofs +{[16,17]} +{[0,26], 28, 30} +DEAL:0:2d::OK +DEAL:0:3d::make_hanging_node_constraints +{} +{[0,108], 110, 112, 114} +DEAL:0:3d::make_consistent_in_parallel on active dofs +{} +{[0,108], 110, 112, 114} +DEAL:0:3d::make_consistent_in_parallel on relevant dofs +{[64,65], [70,71], [76,83]} +{[0,108], 110, 112, 114, 116, 120, 124, 126, 128} +DEAL:0:3d::OK + +DEAL:1:2d::make_hanging_node_constraints +{[16,17]} +{[0,34]} +DEAL:1:2d::make_consistent_in_parallel on active dofs +{[16,17]} +{[0,34]} +DEAL:1:2d::make_consistent_in_parallel on relevant dofs +{[16,17]} +{[0,34]} +DEAL:1:2d::OK +DEAL:1:3d::make_hanging_node_constraints +{[64,65], [70,71], [76,83]} +{[0,134]} +DEAL:1:3d::make_consistent_in_parallel on active dofs +{[64,65], [70,71], [76,83]} +{[0,134]} +DEAL:1:3d::make_consistent_in_parallel on relevant dofs +{[64,65], [70,71], [76,83]} +{[0,134]} +DEAL:1:3d::OK +