From: wolf Date: Tue, 21 Mar 2000 18:23:12 +0000 (+0000) Subject: Significantly simplify setup of matrices in non-memory-saving mode. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=69d0cf8ef36b868445a787dda32701d0f51fc1d0;p=dealii-svn.git Significantly simplify setup of matrices in non-memory-saving mode. git-svn-id: https://svn.dealii.org/trunk@2605 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/lac/include/lac/sparse_vanka.h b/deal.II/lac/include/lac/sparse_vanka.h index bef2d29292..1e894a80a3 100644 --- a/deal.II/lac/include/lac/sparse_vanka.h +++ b/deal.II/lac/include/lac/sparse_vanka.h @@ -14,7 +14,7 @@ #define __deal2__sparse_vanka_h -/* Copyright Guido Kanschat, 1999 */ +/* Copyright Guido Kanschat, Wolfgang Bangerth 1999, 2000 */ #include @@ -307,23 +307,24 @@ class SparseVanka /** * Compute the inverse of the * block located at position - * #row#. Since the map is used - * quite often, it is generated - * only once in the caller of - * this function and passed to - * this function which first - * clears it. Reusing the map - * makes the process + * #row#. Since the vector is + * used quite often, it is + * generated only once in the + * caller of this function and + * passed to this function which + * first clears it. Reusing the + * vector makes the process * significantly faster than in * the case where this function * re-creates it each time. */ - void compute_inverse (const unsigned int row, - map &local_index); + void compute_inverse (const unsigned int row, + vector &local_indices); }; + /** * Block version of the sparse Vanka preconditioner. This class * divides the matrix into blocks and works on the diagonal blocks diff --git a/deal.II/lac/include/lac/sparse_vanka.templates.h b/deal.II/lac/include/lac/sparse_vanka.templates.h index 013a9e9e52..304e32a3b0 100644 --- a/deal.II/lac/include/lac/sparse_vanka.templates.h +++ b/deal.II/lac/include/lac/sparse_vanka.templates.h @@ -129,23 +129,23 @@ void SparseVanka::compute_inverses (const unsigned int begin, const unsigned int end) { - // set-up the map that will be used + // set-up the vector that will be used // by the functions which we call // below. - map local_index; + vector local_indices; // traverse all rows of the matrix // which are selected for (unsigned int row=begin; row void -SparseVanka::compute_inverse (const unsigned int row, - map &local_index) +SparseVanka::compute_inverse (const unsigned int row, + vector &local_indices) { // first define an alias to the sparsity // pattern of the matrix, since this @@ -156,64 +156,26 @@ SparseVanka::compute_inverse (const unsigned int row, const unsigned int row_length = structure.row_length(row); inverses[row] = new FullMatrix (row_length, row_length); - // mapping between: - // 1 column number of all - // entries in this row, and - // 2 the position within this - // row (as stored in the - // SparsityPattern object - // - // since we do not explicitely - // consider nonsysmmetric sparsity - // patterns, the first element - // of each entry simply denotes - // all degrees of freedom that - // couple with #row#. - local_index.clear (); + + // collect the dofs that couple + // with #row# + local_indices.resize (0); for (unsigned int i=0; i - (structure.column_number(row, i), i)); + local_indices.push_back (structure.column_number(row, i)); + + const unsigned int n_couplings = local_indices.size(); - // Build local matrix and rhs - for (map::const_iterator is=local_index.begin(); - is!=local_index.end(); ++is) - { - // irow loops over all DoFs that - // couple with the present DoF - const unsigned int irow = is->first; - // index of DoF irow in the matrix - // row corresponding to DoF #row#. - // runs between 0 and row_length - const unsigned int i = is->second; - // number of DoFs coupling to - // irow (including irow itself) - const unsigned int irow_length = structure.row_length(irow); - - // for all the DoFs that irow - // couples with - for (unsigned int j=0; j::const_iterator js - = local_index.find(col); - - if (js != local_index.end()) - (*inverses[row])(i,js->second) = matrix->raw_entry(irow,j); - }; - }; + // Build local matrix + for (unsigned int i=0; igauss_jordan(); }; + template template void @@ -228,6 +190,7 @@ SparseVanka::operator ()(Vector &dst, }; + template template void @@ -247,7 +210,7 @@ SparseVanka::apply_preconditioner (Vector &dst, = matrix->get_sparsity_pattern(); -// store whether we shall work on + // store whether we shall work on // the whole matrix, or only on // blocks. this variable is used to // optimize access to vectors a