]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Small changes to due comments on code.
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Tue, 19 Jan 2016 21:40:13 +0000 (22:40 +0100)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Wed, 20 Jan 2016 14:30:56 +0000 (15:30 +0100)
include/deal.II/multigrid/mg_transfer_matrix_free.h
source/multigrid/mg_transfer_matrix_free.cc
tests/matrix_free/parallel_multigrid_adaptive_mf.cc
tests/matrix_free/parallel_multigrid_mf.cc

index 2999a62e9f22315363b52b026cd9905eff75533c..a56fd061ef2694c6df563665a7cdcc4dbe856c1c 100644 (file)
@@ -90,10 +90,10 @@ public:
    * <tt>to_level</tt> using the embedding matrices of the underlying finite
    * element. The previous content of <tt>dst</tt> is overwritten.
    *
-   * @arg src is a vector with as many elements as there are degrees of
+   * @param src is a vector with as many elements as there are degrees of
    * freedom on the coarser level involved.
    *
-   * @arg dst has as many elements as there are degrees of freedom on the
+   * @param dst has as many elements as there are degrees of freedom on the
    * finer level.
    */
   virtual void prolongate (const unsigned int                           to_level,
@@ -102,17 +102,17 @@ public:
 
   /**
    * Restrict a vector from level <tt>from_level</tt> to level
-   * <tt>from_level-1</tt> using the transpose operation of the @p prolongate
+   * <tt>from_level-1</tt> using the transpose operation of the prolongate()
    * method. If the region covered by cells on level <tt>from_level</tt> is
    * smaller than that of level <tt>from_level-1</tt> (local refinement), then
    * some degrees of freedom in <tt>dst</tt> are active and will not be
    * altered. For the other degrees of freedom, the result of the restriction
    * is added.
    *
-   * @arg src is a vector with as many elements as there are degrees of
+   * @param src is a vector with as many elements as there are degrees of
    * freedom on the finer level involved.
    *
-   * @arg dst has as many elements as there are degrees of freedom on the
+   * @param dst has as many elements as there are degrees of freedom on the
    * coarser level.
    */
   virtual void restrict_and_add (const unsigned int from_level,
@@ -170,13 +170,13 @@ private:
   std::vector<std::vector<unsigned int> > level_dof_indices;
 
   /**
-   * Stores the connectivity from parent to child cell numbers.
+   * Stores the connectivity from parent to child cell numbers for each level.
    */
   std::vector<std::vector<std::pair<unsigned int,unsigned int> > > parent_child_connect;
 
   /**
    * Stores the number of cells owned on a given process (sets the bounds for
-   * the worker loops).
+   * the worker loops) for each level.
    */
   std::vector<unsigned int> n_owned_level_cells;
 
@@ -198,11 +198,16 @@ private:
    * elements they appear. We store the data in vectorized form to allow for
    * cheap access. Moreover, we utilize the fact that we only need to store
    * <tt>3<sup>dim</sup></tt> indices.
+   *
+   * Data is organized in terms of each level (outer vector) and the cells on
+   * each level (inner vector).
    */
   std::vector<AlignedVector<VectorizedArray<Number> > > weights_on_refined;
 
   /**
-   * Stores the local indices of Dirichlet boundary conditions on cells.
+   * Stores the local indices of Dirichlet boundary conditions on cells for
+   * all levels (outer index), the cells within the levels (second index), and
+   * the indices on the cell (inner index).
    */
   std::vector<std::vector<std::vector<unsigned short> > > dirichlet_indices;
 
index 31f97d48dc7df0729dd4a55d959e7bed667a69b7..8bb7c5992f875063bb5f1509ed1b8b308ca4abfd 100644 (file)
@@ -340,7 +340,10 @@ void MGTransferMatrixFree<dim,Number>::build
           bool cell_is_remote = !consider_cell;
           for (unsigned int c=0; c<GeometryInfo<dim>::max_children_per_cell; ++c)
             if (cell->child(c)->level_subdomain_id()==tria.locally_owned_subdomain())
-              consider_cell = true;
+              {
+                consider_cell = true;
+                break;
+              }
 
           if (!consider_cell)
             continue;
index fdc6862a8b28e3d1bb7fee97e9c5484017aee666..3d9592d9f74b56c93932c32ecc30989f43e1ad75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014-2015 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -14,7 +14,6 @@
 // ---------------------------------------------------------------------
 
 
-
 // same test as parallel_multigrid_adaptive but using but using adaptive
 // meshes with hanging nodes (doing local smoothing)
 
@@ -44,8 +43,6 @@
 #include <deal.II/matrix_free/matrix_free.h>
 #include <deal.II/matrix_free/fe_evaluation.h>
 
-std::ofstream logfile("output");
-
 
 template <int dim, int fe_degree, int n_q_points_1d = fe_degree+1, typename number=double>
 class LaplaceOperator : public Subscriptor
index 1a38e6d86ffbb9328cd10e1339ca17ec2bf36c5e..81fdb30f0cbc9edd038dc659a5c0cbf9f41a55a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014-2015 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -14,7 +14,6 @@
 // ---------------------------------------------------------------------
 
 
-
 // same test as parallel_multigrid but using matrix-free transfer operations
 // (and including single-precision multigrid preconditioning)
 
@@ -44,8 +43,6 @@
 #include <deal.II/matrix_free/matrix_free.h>
 #include <deal.II/matrix_free/fe_evaluation.h>
 
-std::ofstream logfile("output");
-
 
 template <int dim, int fe_degree, int n_q_points_1d = fe_degree+1, typename number=double>
 class LaplaceOperator : public Subscriptor

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.