From: bangerth Date: Fri, 23 May 2008 22:38:41 +0000 (+0000) Subject: Rename a parameter and point out an inconsistency. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=ff9dadace330fa4593195cef68fa74b9d8aa44a5;p=dealii-svn.git Rename a parameter and point out an inconsistency. git-svn-id: https://svn.dealii.org/trunk@16203 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/include/numerics/matrices.h b/deal.II/deal.II/include/numerics/matrices.h index 53b0ba74a4..1f1f5f6735 100644 --- a/deal.II/deal.II/include/numerics/matrices.h +++ b/deal.II/deal.II/include/numerics/matrices.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -1032,14 +1032,22 @@ class MatrixTools : public MatrixCreator * true) is not presently implemented, * and probably will never because it is * too expensive without direct access to - * the PETSc data structures. A third - * reason against this function is that - * it doesn't handle the case where the - * matrix is distributed across an MPI - * system. + * the PETSc data structures. (This leads + * to the situation where the action + * indicates by the default value of the + * last argument is actually not + * implemented; that argument has + * true as its default value + * to stay consistent with the other + * functions of same name in this class.) + * A third reason against this function + * is that it doesn't handle the case + * where the matrix is distributed across + * an MPI system. * - * However, it is probably necessary in - * most cases. + * This function is used in + * @ref step_17 "step-17" and + * @ref step_18 "step-18". */ static void apply_boundary_values (const std::map &boundary_values, diff --git a/deal.II/deal.II/source/numerics/matrices.all_dimensions.cc b/deal.II/deal.II/source/numerics/matrices.all_dimensions.cc index 0b6fd8ceae..654b871f58 100644 --- a/deal.II/deal.II/source/numerics/matrices.all_dimensions.cc +++ b/deal.II/deal.II/source/numerics/matrices.all_dimensions.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors +// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -38,7 +38,7 @@ MatrixTools::apply_boundary_values (const std::map &boundar SparseMatrix &matrix, Vector &solution, Vector &right_hand_side, - const bool preserve_symmetry) + const bool eliminate_columns) { // Require that diagonals are first // in each row @@ -131,7 +131,7 @@ MatrixTools::apply_boundary_values (const std::map &boundar // symmetric, then do a Gauss // elimination step with the // present row - if (preserve_symmetry) + if (eliminate_columns) { // store the only nonzero entry // of this line for the Gauss @@ -204,7 +204,7 @@ MatrixTools::apply_boundary_values (const std::map &boundar BlockSparseMatrix &matrix, BlockVector &solution, BlockVector &right_hand_side, - const bool preserve_symmetry) + const bool eliminate_columns) { const unsigned int blocks = matrix.n_block_rows(); @@ -368,7 +368,7 @@ MatrixTools::apply_boundary_values (const std::map &boundar // present row. this is a // little more complicated for // block matrices. - if (preserve_symmetry) + if (eliminate_columns) { // store the only nonzero entry // of this line for the Gauss @@ -529,9 +529,9 @@ namespace PETScWrappers PETScMatrix &matrix, PETScVector &solution, PETScVector &right_hand_side, - const bool preserve_symmetry) + const bool eliminate_columns) { - Assert (preserve_symmetry == false, ExcNotImplemented()); + Assert (eliminate_columns == false, ExcNotImplemented()); Assert (matrix.n() == right_hand_side.size(), ExcDimensionMismatch(matrix.n(), right_hand_side.size())); @@ -646,12 +646,12 @@ apply_boundary_values (const std::map &boundary_values, PETScWrappers::SparseMatrix &matrix, PETScWrappers::Vector &solution, PETScWrappers::Vector &right_hand_side, - const bool preserve_symmetry) + const bool eliminate_columns) { // simply redirect to the generic function // used for both petsc matrix types PETScWrappers::apply_boundary_values (boundary_values, matrix, solution, - right_hand_side, preserve_symmetry); + right_hand_side, eliminate_columns); } @@ -662,12 +662,12 @@ apply_boundary_values (const std::map &boundary_values, PETScWrappers::MPI::SparseMatrix &matrix, PETScWrappers::MPI::Vector &solution, PETScWrappers::MPI::Vector &right_hand_side, - const bool preserve_symmetry) + const bool eliminate_columns) { // simply redirect to the generic function // used for both petsc matrix types PETScWrappers::apply_boundary_values (boundary_values, matrix, solution, - right_hand_side, preserve_symmetry); + right_hand_side, eliminate_columns); // compress the matrix once we're done matrix.compress (); @@ -803,14 +803,14 @@ MatrixTools::apply_boundary_values (const std::map SparseMatrix &matrix, Vector &solution, Vector &right_hand_side, - const bool preserve_symmetry); + const bool eliminate_columns); template void MatrixTools::apply_boundary_values (const std::map &boundary_values, SparseMatrix &matrix, Vector &solution, Vector &right_hand_side, - const bool preserve_symmetry); + const bool eliminate_columns); template void @@ -818,13 +818,13 @@ MatrixTools::apply_boundary_values (const std::map BlockSparseMatrix &matrix, BlockVector &solution, BlockVector &right_hand_side, - const bool preserve_symmetry); + const bool eliminate_columns); template void MatrixTools::apply_boundary_values (const std::map &boundary_values, BlockSparseMatrix &matrix, BlockVector &solution, BlockVector &right_hand_side, - const bool preserve_symmetry); + const bool eliminate_columns); DEAL_II_NAMESPACE_CLOSE