From: Wolfgang Bangerth Date: Fri, 31 May 2013 04:53:43 +0000 (+0000) Subject: Make ConstraintMatrix::distribute also work for block vectors. Needs a couple extra... X-Git-Tag: v8.0.0~365 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=169456a1b4b9b67f6e62a530e835a036da790939;p=dealii.git Make ConstraintMatrix::distribute also work for block vectors. Needs a couple extra functions in the PETSc block vectors. git-svn-id: https://svn.dealii.org/trunk@29677 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/lac/constraint_matrix.templates.h b/deal.II/include/deal.II/lac/constraint_matrix.templates.h index a1c17c9538..5758495937 100644 --- a/deal.II/include/deal.II/lac/constraint_matrix.templates.h +++ b/deal.II/include/deal.II/lac/constraint_matrix.templates.h @@ -988,69 +988,52 @@ namespace internal #ifdef DEAL_II_WITH_TRILINOS void import_vector_with_ghost_elements (const TrilinosWrappers::MPI::Vector &vec, - const IndexSet &/*locally_owned_elements*/, - const IndexSet &needed_elements, - TrilinosWrappers::MPI::Vector &output) + const IndexSet &/*locally_owned_elements*/, + const IndexSet &needed_elements, + TrilinosWrappers::MPI::Vector &output, + const internal::bool2type /*is_block_vector*/) { output.reinit (needed_elements, dynamic_cast(&vec.vector_partitioner().Comm())->GetMpiComm()); output = vec; } - - - void - import_vector_with_ghost_elements (const TrilinosWrappers::Vector &vec, - const IndexSet &, - const IndexSet &, - TrilinosWrappers::Vector &output) - { - output.reinit (vec.size()); - output = vec; - } #endif #ifdef DEAL_II_WITH_PETSC void import_vector_with_ghost_elements (const PETScWrappers::MPI::Vector &vec, - const IndexSet &locally_owned_elements, - const IndexSet &needed_elements, - PETScWrappers::MPI::Vector &output) + const IndexSet &locally_owned_elements, + const IndexSet &needed_elements, + PETScWrappers::MPI::Vector &output, + const internal::bool2type /*is_block_vector*/) { output.reinit (vec.get_mpi_communicator(), locally_owned_elements, needed_elements); output = vec; } - - - - void - import_vector_with_ghost_elements (const PETScWrappers::Vector &vec, - const IndexSet &, - const IndexSet &, - PETScWrappers::Vector &output) - { - output.reinit (vec.size()); - output = vec; - } #endif template void import_vector_with_ghost_elements (const parallel::distributed::Vector &vec, - const IndexSet &locally_owned_elements, - const IndexSet &needed_elements, - parallel::distributed::Vector &output) + const IndexSet &locally_owned_elements, + const IndexSet &needed_elements, + parallel::distributed::Vector &output, + const internal::bool2type /*is_block_vector*/) { output.reinit (locally_owned_elements, needed_elements, vec.get_mpi_communicator()); output = vec; } - template + // all other vector non-block vector types are sequential and we should + // not have this function called at all -- so throw an exception + template void - import_vector_with_ghost_elements (const dealii::Vector &vec, - const IndexSet &locally_owned_elements, - const IndexSet &needed_elements, - dealii::Vector &output) + import_vector_with_ghost_elements (const Vector &/*vec*/, + const IndexSet &/*locally_owned_elements*/, + const IndexSet &/*needed_elements*/, + Vector &/*output*/, + const internal::bool2type /*is_block_vector*/) { Assert (false, ExcMessage ("We shouldn't even get here!")); } @@ -1059,20 +1042,26 @@ namespace internal // for block vectors, simply dispatch to the individual blocks template void - import_vector_with_ghost_elements (const BlockVectorBase &vec, - const IndexSet &locally_owned_elements, - const IndexSet &needed_elements, - BlockVectorBase &output) + import_vector_with_ghost_elements (const VectorType &vec, + const IndexSet &locally_owned_elements, + const IndexSet &needed_elements, + VectorType &output, + const internal::bool2type /*is_block_vector*/) { + output.reinit (vec.n_blocks()); + types::global_dof_index block_start = 0; for (unsigned int b=0; b()); block_start += vec.block(b).size(); } + + output.collect_sizes (); } } } @@ -1131,7 +1120,8 @@ ConstraintMatrix::distribute (VectorType &vec) const VectorType ghosted_vector; internal::import_vector_with_ghost_elements (vec, vec_owned_elements, needed_elements, - ghosted_vector); + ghosted_vector, + internal::bool2type::value>()); for (constraint_iterator it = lines.begin(); it != lines.end(); ++it) diff --git a/deal.II/include/deal.II/lac/petsc_block_vector.h b/deal.II/include/deal.II/lac/petsc_block_vector.h index 788d8872b2..0c55816a93 100644 --- a/deal.II/include/deal.II/lac/petsc_block_vector.h +++ b/deal.II/include/deal.II/lac/petsc_block_vector.h @@ -1,7 +1,7 @@ //--------------------------------------------------------------------------- // $Id$ // -// Copyright (C) 2004, 2005, 2006, 2007, 2010, 2012 by the deal.II authors +// Copyright (C) 2004, 2005, 2006, 2007, 2010, 2012, 2013 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -259,6 +259,19 @@ namespace PETScWrappers void reinit (const BlockVector &V, const bool fast=false); + /** + * Change the number of blocks to + * num_blocks. The individual + * blocks will get initialized with + * zero size, so it is assumed that + * the user resizes the + * individual blocks by herself + * in an appropriate way, and + * calls collect_sizes + * afterwards. + */ + void reinit (const unsigned int num_blocks); + /** * Swap the contents of this * vector and the other vector @@ -458,6 +471,15 @@ namespace PETScWrappers + inline + void + BlockVector::reinit (const unsigned int num_blocks) + { + reinit (num_blocks, 0, true); + } + + + inline void BlockVector::swap (BlockVector &v) diff --git a/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h b/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h index 33482381d2..70c3606c64 100644 --- a/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h +++ b/deal.II/include/deal.II/lac/petsc_parallel_block_vector.h @@ -1,7 +1,7 @@ //--------------------------------------------------------------------------- // $Id$ // -// Copyright (C) 2004, 2005, 2006, 2007, 2009, 2010, 2012 by the deal.II authors +// Copyright (C) 2004, 2005, 2006, 2007, 2009, 2010, 2012, 2013 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -279,6 +279,19 @@ namespace PETScWrappers void reinit (const std::vector ¶llel_partitioning, const MPI_Comm &communicator); + /** + * Change the number of blocks to + * num_blocks. The individual + * blocks will get initialized with + * zero size, so it is assumed that + * the user resizes the + * individual blocks by herself + * in an appropriate way, and + * calls collect_sizes + * afterwards. + */ + void reinit (const unsigned int num_blocks); + /** * Return a reference to the MPI * communicator object in use with diff --git a/deal.II/source/lac/petsc_parallel_block_vector.cc b/deal.II/source/lac/petsc_parallel_block_vector.cc index fc11d85a10..49318b3840 100644 --- a/deal.II/source/lac/petsc_parallel_block_vector.cc +++ b/deal.II/source/lac/petsc_parallel_block_vector.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2004, 2005, 2006, 2008, 2012 by the deal.II authors +// Copyright (C) 2004, 2005, 2006, 2008, 2012, 2013 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -35,6 +35,21 @@ namespace PETScWrappers return *this; } + + + void + BlockVector::reinit (const unsigned int num_blocks) + { + std::vector block_sizes (num_blocks, 0); + this->block_indices.reinit (block_sizes); + if (this->components.size() != this->n_blocks()) + this->components.resize(this->n_blocks()); + + for (unsigned int i=0; in_blocks(); ++i) + components[i].reinit (MPI_Comm(), 0, 0); + + collect_sizes(); + } } }