From: Daniel Arndt Date: Sat, 23 Mar 2019 03:00:35 +0000 (+0100) Subject: Create local variables in output_results X-Git-Tag: v9.1.0-rc1~255^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=8e227a8497a5dd75b3d9a0e1d08525249cacc706;p=dealii.git Create local variables in output_results --- diff --git a/examples/step-41/step-41.cc b/examples/step-41/step-41.cc index 662829c150..f2e5ec1171 100644 --- a/examples/step-41/step-41.cc +++ b/examples/step-41/step-41.cc @@ -101,7 +101,6 @@ namespace Step41 TrilinosWrappers::SparseMatrix complete_system_matrix; TrilinosWrappers::MPI::Vector solution; - TrilinosWrappers::MPI::Vector active_set_vector; TrilinosWrappers::MPI::Vector system_rhs; TrilinosWrappers::MPI::Vector complete_system_rhs; TrilinosWrappers::MPI::Vector diagonal_of_mass_matrix; @@ -262,7 +261,6 @@ namespace Step41 IndexSet solution_index_set = dof_handler.locally_owned_dofs(); solution.reinit(solution_index_set, MPI_COMM_WORLD); - active_set_vector.reinit(solution_index_set, MPI_COMM_WORLD); system_rhs.reinit(solution_index_set, MPI_COMM_WORLD); complete_system_rhs.reinit(solution_index_set, MPI_COMM_WORLD); contact_force.reinit(solution_index_set, MPI_COMM_WORLD); @@ -544,10 +542,6 @@ namespace Step41 BoundaryValues(), constraints); constraints.close(); - - active_set_vector = 0.; - for (const auto index : active_set) - active_set_vector[index] = 1.; } // @sect4{ObstacleProblem::solve} @@ -588,6 +582,11 @@ namespace Step41 { std::cout << " Writing graphical output..." << std::endl; + TrilinosWrappers::MPI::Vector active_set_vector( + dof_handler.locally_owned_dofs(), MPI_COMM_WORLD); + for (const auto index : active_set) + active_set_vector[index] = 1.; + DataOut data_out; data_out.attach_dof_handler(dof_handler); diff --git a/examples/step-42/step-42.cc b/examples/step-42/step-42.cc index ec2b52df79..5b6127b942 100644 --- a/examples/step-42/step-42.cc +++ b/examples/step-42/step-42.cc @@ -701,7 +701,6 @@ namespace Step42 TrilinosWrappers::SparseMatrix newton_matrix; TrilinosWrappers::MPI::Vector solution; - TrilinosWrappers::MPI::Vector active_set_vector; TrilinosWrappers::MPI::Vector newton_rhs; TrilinosWrappers::MPI::Vector newton_rhs_uncondensed; TrilinosWrappers::MPI::Vector diag_mass_matrix_vector; @@ -1023,7 +1022,6 @@ namespace Step42 { TimerOutput::Scope t(computing_timer, "Setup: vectors"); solution.reinit(locally_relevant_dofs, mpi_communicator); - active_set_vector.reinit(locally_relevant_dofs, MPI_COMM_WORLD); newton_rhs.reinit(locally_owned_dofs, mpi_communicator); newton_rhs_uncondensed.reinit(locally_owned_dofs, mpi_communicator); diag_mass_matrix_vector.reinit(locally_owned_dofs, mpi_communicator); @@ -1341,14 +1339,6 @@ namespace Step42 all_constraints.close(); all_constraints.merge(constraints_dirichlet_and_hanging_nodes); - // We misuse distributed_solution for updating active_set_vector. - // We can do that because distributed_solution has a compatible underlying - // IndexSet and we don't need the vector anymore. - distributed_solution = 0.; - for (const auto index : active_set) - distributed_solution[index] = 1.; - active_set_vector = distributed_solution; - pcout << " Size of active set: " << Utilities::MPI::sum((active_set & locally_owned_dofs).n_elements(), mpi_communicator) @@ -2037,6 +2027,16 @@ namespace Step42 mpi_communicator); lambda = distributed_lambda; + TrilinosWrappers::MPI::Vector distributed_active_set_vector( + locally_owned_dofs, mpi_communicator); + distributed_active_set_vector = 0.; + for (const auto index : active_set) + distributed_active_set_vector[index] = 1.; + distributed_lambda.compress(VectorOperation::insert); + + TrilinosWrappers::MPI::Vector active_set_vector(locally_relevant_dofs, + mpi_communicator); + active_set_vector = distributed_active_set_vector; DataOut data_out;