]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Remove references to tutorial programs that weren't ready yet.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 24 Jun 2010 23:38:14 +0000 (23:38 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 24 Jun 2010 23:38:14 +0000 (23:38 +0000)
git-svn-id: https://svn.dealii.org/branches/releases/Branch-6-3@21358 0785d39b-7218-0410-832d-ea1e28bc413d

16 files changed:
deal.II/base/include/base/conditional_ostream.h
deal.II/base/include/base/timer.h
deal.II/base/include/base/utilities.h
deal.II/deal.II/include/dofs/dof_tools.h
deal.II/deal.II/include/grid/filtered_iterator.h
deal.II/doc/doxygen/headers/geodynamics.h
deal.II/doc/doxygen/headers/glossary.h
deal.II/doc/doxygen/headers/multithreading.h
deal.II/doc/doxygen/headers/software.h
deal.II/examples/step-16/doc/results.dox
deal.II/examples/step-31/doc/intro.dox
deal.II/examples/step-31/doc/results.dox
deal.II/examples/step-35/step-35.cc
deal.II/lac/include/lac/block_sparsity_pattern.h
deal.II/lac/include/lac/constraint_matrix.h
deal.II/lac/include/lac/petsc_parallel_vector.h

index bc7dafbd56d8e99e78dc017c446797aea6f99249..c763f6b121b2fcccfb0a93f66e86042803cc98c4 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -29,7 +29,7 @@ DEAL_II_NAMESPACE_OPEN
  * depending on the ConditionalOStream object being active (default)
  * or not. The condition of this object can be changed by
  * set_condition() and in the constructor. This class is used in the
- * step-17, step-18, step-32,
+ * step-17, step-18,
  * step-33, and step-35
  * tutorial programs.
  *
index 26775ee1a2e664fe6980a381156911dfe51b5c9f..7adef1327c33d73e15e9913c6317dd8ef08cd730 100644 (file)
@@ -349,8 +349,6 @@ class Timer
  * object. In this case, we did a lot of other stuff, so that the time
  * proportions of the functions we measured are far away from 100 precent.
  *
- * See the step-32 tutorial program for usage of this class.
- *
  * @ingroup utilities
  * @author M. Kronbichler, 2009.
  */
index ee7d56796c34a97db68711096527023a311eb51c..fd77d3cdd07030e92520af55565e2505a49c6dad 100644 (file)
@@ -348,9 +348,6 @@ namespace Utilities
                                      * destructor of this object which in
                                      * turns calls <code>MPI_Finalize</code>
                                      * to shut down the MPI system.
-                                     *
-                                     * This class is used in @ref step_32
-                                     * "step-32", for example.
                                      */
     class MPI_InitFinalize
     {
@@ -411,8 +408,7 @@ namespace Utilities
    * provides a unified interface to both serial and %parallel
    * implementations of Trilinos, sets up the MPI communicator in case the
    * programs are run in %parallel, and correctly terminates all processes
-   * when the destructor is called. An example usage of this class is shown
-   * in the tutorial program step-32.
+   * when the destructor is called.
    */
 #ifdef DEAL_II_USE_TRILINOS
   namespace Trilinos
index 5aa9a647e36747ed12227a413e85e01c0f6575d3..28ff513f2c1e111d3d91432f7b5b5bf9c1a4081b 100644 (file)
@@ -445,8 +445,7 @@ class DoFTools
                                      * builds that part of the sparsity
                                      * pattern that corresponds to the
                                      * subdomain_id for which it is
-                                     * responsible. This feature is
-                                     * step-32.
+                                     * responsible.
                                      */
     template <class DH, class SparsityPattern>
     static
@@ -601,8 +600,7 @@ class DoFTools
                                      * builds that part of the sparsity
                                      * pattern that corresponds to the
                                      * subdomain_id for which it is
-                                     * responsible. This feature is
-                                     * step-32.
+                                     * responsible.
                                      */
     template <class DH, class SparsityPattern>
     static
@@ -1421,9 +1419,8 @@ class DoFTools
                                      * case, an assertion is thrown.
                                      *
                                      * This function is used in the
-                                     * step-22,
-                                     * step-31, and
-                                     * step-32 tutorial
+                                     * step-22 and
+                                     * step-31 tutorial
                                      * programs.
                                      */
     template <int dim, int spacedim>
index 0a7fb902972a052d84c370c1105df8c364f31429..e76b9aa73788d598142c16fd51d2572c2f39ee53 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2009 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -48,7 +48,7 @@ namespace IteratorFilters
                                    *
                                    * @ingroup Iterators
                                    */
-  class Active 
+  class Active
   {
     public:
                                       /**
@@ -59,7 +59,7 @@ namespace IteratorFilters
       template <class Iterator>
       bool operator () (const Iterator &i) const;
   };
-  
+
                                   /**
                                    * Filter that evaluates to true if
                                    * either the iterator points to an
@@ -81,7 +81,7 @@ namespace IteratorFilters
       template <class Iterator>
       bool operator () (const Iterator &i) const;
   };
-  
+
 
                                   /**
                                    * Filter that evaluates to true if
@@ -106,7 +106,7 @@ namespace IteratorFilters
       bool operator () (const Iterator &i) const;
   };
 
-  
+
                                   /**
                                    * Filter for iterators that
                                    * evaluates to true if either the
@@ -117,7 +117,7 @@ namespace IteratorFilters
                                    *
                                    * @ingroup Iterators
                                    */
-  class LevelEqualTo 
+  class LevelEqualTo
   {
     public:
                                       /**
@@ -161,7 +161,7 @@ namespace IteratorFilters
                                    *
                                    * @ingroup Iterators
                                    */
-  class SubdomainEqualTo 
+  class SubdomainEqualTo
   {
     public:
                                       /**
@@ -208,8 +208,7 @@ namespace IteratorFilters
  * called with a pair of iterators denoting a range on which they
  * shall act, by choosing a filtered iterator instead of usual ones.
  *
- * This class is used in step-18 and
- * step-32.
+ * This class is used in step-18.
  *
  *
  * <h3>Predicates</h3>
@@ -245,7 +244,7 @@ namespace IteratorFilters
  *   {
  *     return (static_cast<unsigned int>(c->level()) == level);
  *   };
- * @endcode 
+ * @endcode
  * then
  * @code
  *   std::bind2nd (std::ptr_fun(&level_equal_to<active_cell_iterator>), 3)
@@ -257,7 +256,7 @@ namespace IteratorFilters
  *
  * Finally, classes can be predicates. The following class is one:
  * @code
- *   class Active 
+ *   class Active
  *   {
  *     public:
  *       template <class Iterator>
@@ -432,7 +431,7 @@ class FilteredIterator : public BaseIterator
                                      * will automatically be advanced
                                      * to the first cell that has.
                                      */
-    template <typename Predicate>    
+    template <typename Predicate>
     FilteredIterator (Predicate           p,
                      const BaseIterator &bi);
 
@@ -447,7 +446,7 @@ class FilteredIterator : public BaseIterator
                                      * Destructor.
                                      */
     ~FilteredIterator ();
-    
+
                                     /**
                                      * Assignment operator. Copy the
                                      * iterator value of the
@@ -490,7 +489,7 @@ class FilteredIterator : public BaseIterator
                                      */
     FilteredIterator &
     set_to_next_positive (const BaseIterator &bi);
-    
+
                                     /**
                                      * As above, but search for the
                                      * previous iterator from @p bi
@@ -507,7 +506,7 @@ class FilteredIterator : public BaseIterator
                                      */
     FilteredIterator &
     set_to_previous_positive (const BaseIterator &bi);
-    
+
                                     /**
                                      * Compare for equality of the
                                      * underlying iterator values of
@@ -559,7 +558,7 @@ class FilteredIterator : public BaseIterator
                                      *
                                      * We do not compare the
                                      * predicates.
-                                     */    
+                                     */
     bool operator <  (const FilteredIterator &fi) const;
 
                                     /**
@@ -618,7 +617,7 @@ class FilteredIterator : public BaseIterator
                    << "The element " << arg1
                    << " with which you want to compare or which you want to"
                    << " assign from is invalid since it does not satisfy the predicate.");
-    
+
   private:
 
                                     /**
@@ -705,7 +704,7 @@ class FilteredIterator : public BaseIterator
                                          * type of this pointer.
                                          */
        virtual PredicateBase * clone () const;
-       
+
       private:
                                         /**
                                          * Copy of the predicate.
@@ -830,7 +829,7 @@ FilteredIterator<BaseIterator>::
 operator = (const BaseIterator &bi)
 {
   Assert ((bi.state() != IteratorState::valid) || (*predicate)(bi),
-         ExcInvalidElement(bi));  
+         ExcInvalidElement(bi));
   BaseIterator::operator = (bi);
   return *this;
 }
@@ -847,7 +846,7 @@ set_to_next_positive (const BaseIterator &bi)
   while ((this->state() == IteratorState::valid) &&
         ( ! (*predicate)(*this)))
     BaseIterator::operator++ ();
-  
+
   return *this;
 }
 
@@ -863,7 +862,7 @@ set_to_previous_positive (const BaseIterator &bi)
   while ((this->state() == IteratorState::valid) &&
         ( ! (*predicate)(*this)))
     BaseIterator::operator-- ();
-  
+
   return *this;
 }
 
@@ -964,7 +963,7 @@ FilteredIterator<BaseIterator>::
 operator ++ (int)
 {
   const FilteredIterator old_state = *this;
-  
+
   if (this->state() == IteratorState::valid)
     do
       BaseIterator::operator++ ();
@@ -999,7 +998,7 @@ FilteredIterator<BaseIterator>::
 operator -- (int)
 {
   const FilteredIterator old_state = *this;
-  
+
   if (this->state() == IteratorState::valid)
     do
       BaseIterator::operator-- ();
@@ -1043,7 +1042,7 @@ clone () const
 
 
 
-namespace IteratorFilters 
+namespace IteratorFilters
 {
 
 // ---------------- IteratorFilters::Active ---------
@@ -1079,7 +1078,7 @@ namespace IteratorFilters
   }
 
 
-// ---------------- IteratorFilters::LevelEqualTo ---------  
+// ---------------- IteratorFilters::LevelEqualTo ---------
   inline
   LevelEqualTo::LevelEqualTo (const unsigned int level)
                  :
index 47afee7243fc2406c1ac22cbcbd63ec385879717..337924f2f6e3eea84683be11e0425c6842f90fc9 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2009 by the deal.II authors
+//    Copyright (C) 2009, 2010 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -33,7 +33,6 @@ programs:
 - step-21: Multiphase flow through porous media
 - step-22: Stokes flow
 - step-31: Thermal convection (Boussinesq flow)
-- step-32: A %parallel Boussinesq solver for mantle convection
 
 Some of these programs were developed under contract from the California
 Institute of Technology with support by the National Science Foundation
@@ -122,7 +121,7 @@ problems. In particular, they are aimed at the following goals:
   correctness. Existing tutorial programs typically employ simpler rather than
   more complicated solver schemes for exposition but frequently suggest more
   complicated schemes including hints on how they might be implemented in an
-  appendix. 
+  appendix.
 
 <li> <i>Try algorithms:</i> The rapid prototyping abilities of deal.II may
   also help in determining best algorithms on the scale of programs to which
index 20b4557775bda7529bfdee0ba346766b9d28bd36..dfc8ca7628698bbbf995fe640beb93a2b087183c 100644 (file)
@@ -632,7 +632,7 @@ Article{JK10,
  * a vector-valued element has exactly one nonzero component if an element is
  * primitive. This includes, in particular, all scalar elements as well as
  * vector-valued elements assembled via the FESystem class from other
- * primitive (for example scalar) elements as shown in step-8, 
+ * primitive (for example scalar) elements as shown in step-8,
  * step-29, step-22 and several others. On the other hand,
  * the FE_RaviartThomas class used in step-20 and step-21, or the FE_Nedelec
  * class provide non-primitive finite elements because there, each
@@ -659,8 +659,8 @@ Article{JK10,
  * cell is associated with.
  *
  * For programs that are parallelized based on MPI but where each processor
- * stores the entire triangulation (as in, for example, step-18
- * or step-32, subdomain ids are assigned to cells by
+ * stores the entire triangulation (as in, for example, step-18,
+ * subdomain ids are assigned to cells by
  * partitioning a mesh, and each MPI process then only works on those cells it
  * "owns", i.e. that belong to a subdomain that it is associated with
  * (traditionally, this is the case for the subdomain id whose numerical value
index d671c516cd70dbd9f4eee63e7969e03e4ec990fa..b6c2e26f912bc9bb82b5e51e933fe3229baa7ac4 100644 (file)
  * namespace. The MultithreadInfo class allows to query certain
  * properties of the system, such as the number of CPUs. These
  * facilities for %parallel computing are described in the
- * following. The step-9, step-13, step-14, step-32, step-35 and
- * step-37 tutorial programs also show their use in practice, with the
- * ones starting with step-32 using a more modern style of doing
+ * following. The step-9, step-13, step-14, and step-35
+ * tutorial programs also show their use in practice, with the
+ * ones starting with step-35 using a more modern style of doing
  * things in which essentially we describe <i>what</i> can be done in
  * %parallel, while the older tutorial programs describe <i>how</i>
  * things have to be done in %parallel.
  *
  * On the other hand, programs running on distributed memory machines
  * (i.e. clusters) need a different programming model built on top of MPI and
- * PETSc or Trilinos. This is described in the step-17, step-18 and step-32
+ * PETSc or Trilinos. This is described in the step-17, and step-18
  * example programs.
  *
  * @anchor MTToC
  * in at the positions indicated by <code>_1, _2</code> and <code>_3</code>.
  *
  * To see the WorkStream class used in practice on tasks like the ones
- * outlined above, take a look at the step-32, step-35 or step-37
- * tutorial programs.
+ * outlined above, take a look at the step-35
+ * tutorial program.
  *
  *
  * @anchor MTThreads
 
    // In the program, before any task-based parallelism is reached.
    // Early in the main method is a good place to call this:
-   tbb::task_scheduler_init init(n_desired_threads + 1); 
+   tbb::task_scheduler_init init(n_desired_threads + 1);
  * @endcode
  * The method of setting the number of threads relies on this call to
  * <code>task_scheduler_init</code> occurring before any other calls to the
index 47822900b15828afa9421b11de855174c5d72b71..43098d25522c22a061b1af6e01a9d7680cf9c937 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
  * Interfaces to Trilinos exist in the TrilinosWrappers namespace,
  * making matrices, vectors, and solvers look like the corresponding
  * deal.II classes. Their use is explained in the @ref step_31
- * "step-31", step-32, and step-33
+ * "step-31", and step-33
  * tutorial programs.  The <a
  * href="../../readme-petsc-trilinos.html">PETSc and Trilinos
  * ReadMe</a> file explains how to configure deal.II to use this
index 762f8091b40d202cd3919455a636be5e888a1659..e995f32cd9580bf1b8912cc277f522271fa4ccad 100644 (file)
@@ -86,7 +86,7 @@ for second order problems.
 <h3> Possible extensions </h3>
 
 A close inspection of this program's performance shows that it is mostly
-dominated by matrix-vector operations. step-37 shows one way
+dominated by matrix-vector operations. The future step 37 will show one way
 how this can be avoided by working with matrix-free methods.
 
 Another avenue would be to use algebraic multigrid methods. The
index 792ff9cc60e10af20836ff76d15dac05b33af293..426eeb414ec9279241fdd0b2c37f44836774b1c7 100644 (file)
@@ -54,8 +54,7 @@ The forcing term of the fluid motion is the buoyancy of the
 fluid, expressed as the product of the density $\rho$, the thermal expansion
 coefficient $\beta$,
 the temperature <i>T</i> and the gravity vector <b>g</b> pointing
-downward. (A derivation of why the right hand side looks like it looks
-is given in the introduction of step-32.)
+downward.
 While the first two equations describe how the fluid reacts to
 temperature differences by moving around, the third equation states
 how the fluid motion affects the temperature field: it is an advection
@@ -962,7 +961,7 @@ the latter class, one of the most interesting capabilities is the existence of
 the Trilinos ML package that implements an Algebraic Multigrid (AMG)
 method. We will use this preconditioner to precondition the second order
 operator part of the momentum equation. The ability to solve problems in
-%parallel will be explored in step-32, using the same problem as
+%parallel will be explored in a future step 32, using the same problem as
 discussed here.
 
 
index 5f44a5db925a7e31ba8ab46f2b92ea6283ba464a..58432cac0d3246cd6498cba057b0d2d1dfbeb8a3 100644 (file)
@@ -344,7 +344,7 @@ $c_R=\left(2^{1/d}\right)^{4-2\alpha}=2^{\frac{4-2\alpha}{d}}$. Since
 this value for $c_R$ appears to work just fine for the current
 program, we corrected the formula in the program and set $c_R$ to a
 value that reproduces exactly the results we had before. We will,
-however, revisit this issue again in step-32.
+however, revisit this issue again in a future step 32.
 
 Now, however, back to the discussion of what values of $c_k$ and
 $\beta$ to choose:
@@ -587,7 +587,7 @@ despite the penalty we pay in terms of smaller time steps.
 
 There are various ways to extend the current program. Of particular interest
 is, of course, to make it faster and/or increase the resolution of the
-program, in particular in 3d. This is the topic of the step-32
+program, in particular in 3d. This is the topic of the future step 32
 tutorial program which will implement strategies to solve this problem in
 %parallel on a cluster.
 
index 4554dcf0b842c606a4fdc4cfcb644696ec543496..dfc08f06213b141d6329bb44c5e6b067b8944862 100644 (file)
@@ -1,7 +1,7 @@
 /* $Id$ */
 /* Version: $Name:  $ */
 /*      */
-/*    Copyright (C) 2007, 2008, 2009 by the deal.II authors */
+/*    Copyright (C) 2007, 2008, 2009, 2010 by the deal.II authors */
 /*    Author: Abner Salgado, Texas A&M University 2009 */
 /*                                                                */
 /*    This file is subject to QPL and may not be  distributed     */
@@ -1369,8 +1369,8 @@ NavierStokesProjection<dim>::update_pressure (const bool reinit_prec)
                                 // graphical output.
                                 //
                                 // We will not elaborate on this process
-                                // here, but rather refer to step-31 and
-                                // step-32, where a similar procedure is used
+                                // here, but rather refer to step-31,
+                                // where a similar procedure is used
                                 // (and is documented) to create a joint
                                 // DoFHandler object for all variables.
                                 //
index 4967802bc929e900880859eb8fea410825f3bcb8..c35efa18223f1bddc596e083d68f3c5162ed361b 100644 (file)
@@ -954,8 +954,6 @@ class BlockCompressedSimpleSparsityPattern : public BlockSparsityPatternBase<Com
  * (in the sense that the method compress() needs to be called before the
  * pattern can be used).
  *
- * This class is used in step-32.
- *
  * @author Martin Kronbichler, 2008, 2009
  */
 namespace TrilinosWrappers
index dd7a32f0c950da186d6ecb106988c818d510db6c..d7c24a61f6a4a9ff9aed4d0394401d0760d07b36 100644 (file)
@@ -290,7 +290,7 @@ namespace internals
  * where we have no access to the underlying representation of the matrix,
  * and therefore cannot efficiently implement the condense()
  * operation). This is the case discussed in step-17, @ref
- * step_18 "step-18", step-31, and step-32.
+ * step_18 "step-18", and step-31.
  * </ul>
  *
  * In this case, one possibility is to distribute local entries to the final
@@ -374,7 +374,7 @@ class ConstraintMatrix : public Subscriptor
                                      * filter. Constrained dofs are
                                      * transformed to local index space of
                                      * the filter, and elements not present
-                                     * in the IndexSet are ignored. 
+                                     * in the IndexSet are ignored.
                                      *
                                      * This function provides an easy way to
                                      * create a ConstraintMatrix for certain
@@ -467,7 +467,7 @@ class ConstraintMatrix : public Subscriptor
                                      * set_inhomogeneity().
                                      */
     void add_lines (const IndexSet &lines);
-    
+
                                     /**
                                      * Add an entry to a given
                                      * line. The list of lines is
@@ -1336,7 +1336,7 @@ class ConstraintMatrix : public Subscriptor
                                       * Does the same as the function above
                                       * but can treat
                                       * non quadratic matrices.
-                                      */    
+                                      */
     template <typename MatrixType>
     void
     distribute_local_to_global (const FullMatrix<double>        &local_matrix,
index bfec7d151aadcb59a598fb557c21cda65ea5757f..3e20ad6ffb2828e26dee2bef2af046326a815299 100644 (file)
@@ -47,7 +47,7 @@ namespace PETScWrappers
  */
   namespace MPI
   {
-    
+
 /**
  * Implementation of a parallel vector class based on PETSC and using MPI
  * communication to synchronise distributed operations. All the functionality
@@ -159,7 +159,7 @@ namespace PETScWrappers
                                           * vector as empty.
                                           */
         Vector ();
-      
+
                                          /**
                                           * Constructor. Set dimension to
                                           * @p n and initialize all
@@ -173,7 +173,7 @@ namespace PETScWrappers
                                           * communicator over which the
                                           * different parts of the vector
                                           * shall communicate
-                                          * 
+                                          *
                                           * The constructor is made explicit
                                           * to avoid accidents like this:
                                           * <tt>v=0;</tt>. Presumably, the user
@@ -187,14 +187,14 @@ namespace PETScWrappers
         explicit Vector (const MPI_Comm     &communicator,
                          const unsigned int  n,
                          const unsigned int  local_size);
-    
-       
+
+
                                          /**
                                           * Copy-constructor from deal.II
                                           * vectors. Sets the dimension to that
                                           * of the given vector, and copies all
                                           * elements.
-                                          * 
+                                          *
                                           * @arg local_size denotes the size
                                           * of the chunk that shall be stored
                                           * on the present process.
@@ -209,12 +209,12 @@ namespace PETScWrappers
                          const dealii::Vector<Number> &v,
                          const unsigned int      local_size);
 
-       
+
                                          /**
                                           * Copy-constructor the
                                           * values from a PETSc wrapper vector
                                           * class.
-                                          * 
+                                          *
                                           * @arg local_size denotes the size
                                           * of the chunk that shall be stored
                                           * on the present process.
@@ -245,13 +245,13 @@ namespace PETScWrappers
                                          * ignored during construction. That
                                          * way, the ghost parameter can equal
                                          * the set of locally relevant
-                                         * degrees of freedom, see step-32.
+                                         * degrees of freedom.
                                          */
        explicit Vector (const MPI_Comm     &communicator,
                          const IndexSet &  local,
                          const IndexSet & ghost = IndexSet(0));
-       
-       
+
+
                                          /**
                                           * Copy the given vector. Resize the
                                           * present vector if necessary. Also
@@ -260,7 +260,7 @@ namespace PETScWrappers
                                           */
         Vector & operator = (const Vector &v);
 
-       
+
                                          /**
                                          * Copy the given sequential
                                          * (non-distributed) vector
@@ -347,17 +347,17 @@ namespace PETScWrappers
                                           * @p communicator denotes the MPI
                                           * communicator henceforth to be used
                                           * for this vector.
-                                          * 
+                                          *
                                           * If @p fast is false, the vector
                                           * is filled by zeros. Otherwise, the
                                           * elements are left an unspecified
                                           * state.
-                                          */ 
+                                          */
         void reinit (const MPI_Comm     &communicator,
                      const unsigned int  N,
                      const unsigned int  local_size,
                      const bool          fast = false);
-    
+
                                          /**
                                           * Change the dimension to that of
                                           * the vector @p v, and also take
@@ -384,7 +384,7 @@ namespace PETScWrappers
                      const IndexSet &  local,
                      const IndexSet & ghost = IndexSet(0));
 
-       
+
                                          /**
                                           * Return a reference to the MPI
                                           * communicator object in use with
@@ -418,7 +418,7 @@ namespace PETScWrappers
        virtual void create_vector (const unsigned int  n,
                                    const unsigned int  local_size,
                                    const IndexSet & ghostnodes);
-       
+
 
       private:
                                          /**
@@ -461,8 +461,8 @@ namespace PETScWrappers
       *this = v;
     }
 
-  
-  
+
+
     inline
     Vector &
     Vector::operator = (const PetscScalar s)
@@ -471,7 +471,7 @@ namespace PETScWrappers
 
       return *this;
     }
-  
+
 
 
     inline
@@ -482,10 +482,10 @@ namespace PETScWrappers
                                        // then first resize the present one
       if (size() != v.size())
         reinit (v.communicator, v.size(), v.local_size(), true);
-    
+
       const int ierr = VecCopy (v.vector, vector);
       AssertThrow (ierr == 0, ExcPETScError(ierr));
-    
+
       return *this;
     }
 
@@ -494,7 +494,7 @@ namespace PETScWrappers
     template <typename number>
     inline
     Vector &
-    Vector::operator = (const dealii::Vector<number> &v) 
+    Vector::operator = (const dealii::Vector<number> &v)
     {
       Assert (size() == v.size(),
               ExcDimensionMismatch (size(), v.size()));

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.