]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
revert whitespace changes
authorheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 21 Dec 2012 01:36:49 +0000 (01:36 +0000)
committerheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 21 Dec 2012 01:36:49 +0000 (01:36 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_merge_mg_into_dof_handler@27839 0785d39b-7218-0410-832d-ea1e28bc413d

36 files changed:
deal.II/include/deal.II/base/conditional_ostream.h
deal.II/include/deal.II/base/data_out_base.h
deal.II/include/deal.II/base/exceptions.h
deal.II/include/deal.II/base/geometry_info.h
deal.II/include/deal.II/base/logstream.h
deal.II/include/deal.II/base/parallel.h
deal.II/include/deal.II/base/parameter_handler.h
deal.II/include/deal.II/base/partitioner.h
deal.II/include/deal.II/base/qprojector.h
deal.II/include/deal.II/base/smartpointer.h
deal.II/include/deal.II/base/utilities.h
deal.II/include/deal.II/grid/grid_generator.h
deal.II/include/deal.II/grid/grid_in.h
deal.II/include/deal.II/grid/grid_reordering_internal.h
deal.II/include/deal.II/grid/grid_tools.h
deal.II/include/deal.II/grid/tria_boundary.h
deal.II/include/deal.II/lac/block_matrix_base.h
deal.II/include/deal.II/lac/matrix_block.h
deal.II/include/deal.II/lac/parallel_vector.h
deal.II/include/deal.II/lac/petsc_block_sparse_matrix.h
deal.II/include/deal.II/lac/petsc_block_vector.h
deal.II/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h
deal.II/include/deal.II/lac/sparse_matrix.h
deal.II/include/deal.II/lac/sparsity_pattern.h
deal.II/include/deal.II/lac/trilinos_block_sparse_matrix.h
deal.II/include/deal.II/lac/trilinos_vector_base.h
deal.II/include/deal.II/lac/vector.h
deal.II/include/deal.II/matrix_free/fe_evaluation.h
deal.II/include/deal.II/matrix_free/mapping_info.h
deal.II/include/deal.II/meshworker/integration_info.h
deal.II/include/deal.II/multigrid/mg_coarse.h
deal.II/include/deal.II/numerics/derivative_approximation.h
deal.II/include/deal.II/numerics/error_estimator.h
deal.II/include/deal.II/numerics/matrix_tools.h
deal.II/include/deal.II/numerics/vector_tools.h
deal.II/include/deal.II/numerics/vector_tools.templates.h

index 753ade963e773a7e7cf40565215a26a307826110..d786f5d02e5b06205a1904a9839b57c427b2206e 100644 (file)
@@ -148,7 +148,7 @@ private:
    * Reference to the stream we
    * want to write to.
    */
-  std::ostream  &output_stream;
+  std::ostream &output_stream;
 
   /**
    * Stores the actual condition
index a8124528fc585689d9ca012124fb554db73d4757..f1ff018f5cfa3ff0e37c8e7d044bf8facd157d51 100644 (file)
@@ -2442,7 +2442,7 @@ public:
    * @author Marco Engelhard, 2012
    */
   void write_pvd_record (std::ostream &out,
-                         const std::vector<std::pair<double,std::string> >  &times_and_names) const;
+                         const std::vector<std::pair<double,std::string> > &times_and_names) const;
 
   /**
    * This function is the exact
index d74bbb592bfd9e99628227acfefbf441d0ed33bf..822a0f7fe757eb5134fd9d516acec85f53675905 100644 (file)
@@ -114,7 +114,7 @@ protected:
   /**
    * Name of the file this exception happen in.
    */
-  const char  *file;
+  const char *file;
 
   /**
    * Line number in this file.
@@ -124,17 +124,17 @@ protected:
   /**
    * Name of the function, pretty printed.
    */
-  const char  *function;
+  const char *function;
 
   /**
    * The violated condition, as a string.
    */
-  const char  *cond;
+  const char *cond;
 
   /**
    * Name of the exception and call sequence.
    */
-  const char  *exc;
+  const char *exc;
 
   /**
    * A backtrace to the position where the problem happened, if the
index b2d09128bc89e5dd425f513e0f468933c81a02aa..eaca6197606249b5ed7b97489fa736c5c283860a 100644 (file)
@@ -2736,7 +2736,7 @@ GeometryInfo<3>::cell_to_child_coordinates (const Point<3>         &p,
 template <int dim>
 inline
 Point<dim>
-GeometryInfo<dim>::cell_to_child_coordinates (const Point<dim>         &/*p*/,
+GeometryInfo<dim>::cell_to_child_coordinates (const Point<dim> &         /*p*/,
                                               const unsigned int        /*child_index*/,
                                               const RefinementCase<dim> /*refine_case*/)
 
@@ -2880,7 +2880,7 @@ GeometryInfo<2>::child_to_cell_coordinates (const Point<2>         &p,
 template <int dim>
 inline
 Point<dim>
-GeometryInfo<dim>::child_to_cell_coordinates (const Point<dim>         &/*p*/,
+GeometryInfo<dim>::child_to_cell_coordinates (const Point<dim> &         /*p*/,
                                               const unsigned int        /*child_index*/,
                                               const RefinementCase<dim> /*refine_case*/)
 {
index cb50979e3807875c1617432f729060d9f16054d9..d4d47ef84bdd37ee57332e24c4492fe4ca1ae1c4 100644 (file)
@@ -450,7 +450,7 @@ private:
    * to <tt>std::cerr</tt>, but can be set to another
    * stream through the constructor.
    */
-  std::ostream  *std_out;
+  std::ostream *std_out;
 
   /**
    * Pointer to a stream, where a copy of
@@ -460,7 +460,7 @@ private:
    * You can set and reset this stream
    * by the <tt>attach</tt> function.
    */
-  std::ostream  *file;
+  std::ostream *file;
 
   /**
    * Value denoting the number of
index 0afd44ae30276b9e839608a8307c10a7e1a31f16..2036053859cbfd068a5f67b4597c48a7b8202ff8 100644 (file)
@@ -347,7 +347,7 @@ namespace parallel
      */
     template <typename RangeType, typename Function>
     void apply_to_subranges (const tbb::blocked_range<RangeType> &range,
-                             const Function  &f)
+                             const Function &f)
     {
       f (range.begin(), range.end());
     }
index f19849ef969d18ff37b38f28734cdb594e4a7d97..8d706cba21026c52b34426c7ef3edae764c3352e 100644 (file)
@@ -571,7 +571,7 @@ namespace Patterns
      * and maximal allowable
      * lengths of the list.
      */
-    List (const PatternBase  &base_pattern,
+    List (const PatternBase &base_pattern,
           const unsigned int  min_elements = 0,
           const unsigned int  max_elements = max_int_value);
 
@@ -705,8 +705,8 @@ namespace Patterns
      * and maximal allowable
      * lengths of the list.
      */
-    Map (const PatternBase  &key_pattern,
-         const PatternBase  &value_pattern,
+    Map (const PatternBase &key_pattern,
+         const PatternBase &value_pattern,
          const unsigned int  min_elements = 0,
          const unsigned int  max_elements = max_int_value);
 
index fff826924bb732cf0471cce57af43f88059881de..9203409bf6e3a49c026d46ed72eeb101c3ac4617 100644 (file)
@@ -470,7 +470,7 @@ namespace Utilities
 
 
     inline
-    const IndexSet  &Partitioner::ghost_indices() const
+    const IndexSet &Partitioner::ghost_indices() const
     {
       return ghost_indices_data;
     }
index c89c41ffe7e87f42948c445561fac55b8605bf74..e63769f99b26603907853c9a7f6ddd9be245c1b7 100644 (file)
@@ -123,7 +123,7 @@ public:
   static void project_to_subface (const SubQuadrature       &quadrature,
                                   const unsigned int         face_no,
                                   const unsigned int         subface_no,
-                                  std::vector<Point<dim> >  &q_points,
+                                  std::vector<Point<dim> > &q_points,
                                   const RefinementCase<dim-1> &ref_case=RefinementCase<dim-1>::isotropic_refinement);
 
   /**
@@ -226,7 +226,7 @@ public:
    */
   static
   Quadrature<dim>
-  project_to_child (const Quadrature<dim>  &quadrature,
+  project_to_child (const Quadrature<dim> &quadrature,
                     const unsigned int      child_no);
 
   /**
@@ -249,7 +249,7 @@ public:
    */
   static
   Quadrature<dim>
-  project_to_all_children (const Quadrature<dim>  &quadrature);
+  project_to_all_children (const Quadrature<dim> &quadrature);
 
   /**
    * Project the onedimensional
index 1efb98f93d454f73f400dd59191f2d38e5a5eb03..afb56e0f906a38419fa16b5182840e78dd267b16 100644 (file)
@@ -218,7 +218,7 @@ public:
    * want to change the pointer
    * variable which we are given.
    */
-  void swap (T *&tt);
+  void swap (T  *&tt);
 
   /**
    * Return an estimate of the
@@ -444,7 +444,7 @@ void SmartPointer<T,P>::swap (SmartPointer<T,Q> &tt)
 
 template <typename T, typename P>
 inline
-void SmartPointer<T,P>::swap (T *&tt)
+void SmartPointer<T,P>::swap (T  *&tt)
 {
   if (t != 0)
     t->unsubscribe (id);
@@ -491,7 +491,7 @@ void swap (SmartPointer<T,P> &t1, SmartPointer<T,Q> &t2)
  */
 template <typename T, typename P>
 inline
-void swap (SmartPointer<T,P> &t1, T *&t2)
+void swap (SmartPointer<T,P> &t1, T  *&t2)
 {
   t1.swap (t2);
 }
@@ -507,7 +507,7 @@ void swap (SmartPointer<T,P> &t1, T *&t2)
  */
 template <typename T, typename P>
 inline
-void swap (T *&t1, SmartPointer<T,P> &t2)
+void swap (T  *&t1, SmartPointer<T,P> &t2)
 {
   t2.swap (t1);
 }
index 063d1dd20228d6c3e1145d548c856560ec8559ec..657472427dfa4a63d16968444d7609c20f875581 100644 (file)
@@ -287,7 +287,7 @@ namespace Utilities
   Iterator
   lower_bound (Iterator  first,
                Iterator  last,
-               const T  &val);
+               const T &val);
 
 
   /**
@@ -660,7 +660,7 @@ namespace Utilities
      * the duplicate_communicator() function.
      */
     Epetra_Map
-    duplicate_map (const Epetra_BlockMap  &map,
+    duplicate_map (const Epetra_BlockMap &map,
                    const Epetra_Comm &comm);
   }
 
@@ -705,7 +705,7 @@ namespace Utilities
   Iterator
   lower_bound (Iterator  first,
                Iterator  last,
-               const T  &val)
+               const T &val)
   {
     return Utilities::lower_bound (first, last, val,
                                    std::less<T>());
index 2cea902ac00bf020bd3ffb26ed538b5c3523b4b4..d9a15f9b5fe665920b7557f24e739f67e909eda4 100644 (file)
@@ -83,7 +83,7 @@ public:
    * function.
    */
   template <int dim, int spacedim>
-  static void hyper_cube (Triangulation<dim,spacedim>  &tria,
+  static void hyper_cube (Triangulation<dim,spacedim> &tria,
                           const double        left = 0.,
                           const double        right= 1.);
 
@@ -114,7 +114,7 @@ public:
    * function.
    */
   template <int dim>
-  static void subdivided_hyper_cube (Triangulation<dim>  &tria,
+  static void subdivided_hyper_cube (Triangulation<dim> &tria,
                                      const unsigned int  repetitions,
                                      const double        left = 0.,
                                      const double        right= 1.);
@@ -304,7 +304,7 @@ public:
    */
   template <int dim>
   static void
-  parallelogram(Triangulation<dim>  &tria,
+  parallelogram(Triangulation<dim> &tria,
                 const Tensor<2,dim> &corners,
                 const bool           colorize=false);
 
@@ -787,7 +787,7 @@ public:
    * torus.
    */
 
-  static void torus (Triangulation<2,3>  &tria,
+  static void torus (Triangulation<2,3> &tria,
                      const double         R,
                      const double         r);
 
@@ -841,7 +841,7 @@ public:
    * @param R           The radius of the circle, which forms the middle line of the torus containing the loop of cells. Must be greater than @p r.
    * @param r           The radius of the cylinder bend together as loop.
    */
-  static void moebius (Triangulation<3,3>  &tria,
+  static void moebius (Triangulation<3,3> &tria,
                        const unsigned int   n_cells,
                        const unsigned int   n_rotations,
                        const double         R,
index fbd5110423f3d82aed4f3c7f4a2b281a9d6a2d95..067f89caa4e1083d036cdab885f513e1a767635e 100644 (file)
@@ -581,9 +581,9 @@ private:
    */
   static void parse_tecplot_header(std::string   &header,
                                    std::vector<unsigned int> &tecplot2deal,
-                                   unsigned int  &n_vars,
-                                   unsigned int  &n_vertices,
-                                   unsigned int  &n_cells,
+                                   unsigned int &n_vars,
+                                   unsigned int &n_vertices,
+                                   unsigned int &n_cells,
                                    std::vector<unsigned int> &IJK,
                                    bool          &structured,
                                    bool          &blocked);
index 89c89b7da4fa42099158401affa94c48523dc767..3d15b6f19c5f773bd6878c49954442bfaa9d0a9b 100644 (file)
@@ -125,7 +125,7 @@ namespace internal
              const unsigned int  s1,
              const unsigned int  s2,
              const unsigned int  s3,
-             const CellData<2>  &cd);
+             const CellData<2> &cd);
 
       /**
        * Stores the vertex numbers
index 56fbba891cca3db2bb5832b02401fb93db8f50ab..6abe79967948528289eec8a62288b9680eff34ac 100644 (file)
@@ -332,7 +332,7 @@ namespace GridTools
    */
   template <int dim, template <int,int> class Container, int spacedim>
   typename Container<dim,spacedim>::active_cell_iterator
-  find_active_cell_around_point (const Container<dim,spacedim>  &container,
+  find_active_cell_around_point (const Container<dim,spacedim> &container,
                                  const Point<spacedim> &p);
 
   /**
@@ -588,7 +588,7 @@ namespace GridTools
    */
   template <int dim, int spacedim>
   void
-  get_subdomain_association (const Triangulation<dim, spacedim>  &triangulation,
+  get_subdomain_association (const Triangulation<dim, spacedim> &triangulation,
                              std::vector<types::subdomain_id> &subdomain);
 
   /**
index ef462423f88ebf24603d4711f3280b4e4b75ce04..f093c5eb76684f20aae7a27e1029187bae7231ec 100644 (file)
@@ -691,7 +691,7 @@ template <>
 Point<3>
 StraightBoundary<1,3>::
 project_to_surface (const Triangulation<1, 3>::quad_iterator &quad,
-                    const Point<3>  &y) const;
+                    const Point<3> &y) const;
 
 
 #endif // DOXYGEN
index 8cd475e64170816ac13d72d9e0ce456b2f8d5fdf..d7de0a7eb2bf8d591888da827e0560905db93810 100644 (file)
@@ -1135,7 +1135,7 @@ protected:
    */
   template <class BlockVectorType,
            class VectorType>
-  void Tvmult_block_nonblock (BlockVectorType  &dst,
+  void Tvmult_block_nonblock (BlockVectorType &dst,
                               const VectorType &src) const;
 
   /**
@@ -1289,7 +1289,7 @@ namespace BlockMatrixIterators
   template <class BlockMatrix>
   inline
   Accessor<BlockMatrix, true>::Accessor (
-    const BlockMatrix  *matrix,
+    const BlockMatrix *matrix,
     const unsigned int  row,
     const unsigned int  col)
     :
@@ -1498,7 +1498,7 @@ namespace BlockMatrixIterators
   template <class BlockMatrix>
   inline
   Accessor<BlockMatrix, false>::Accessor (
-    BlockMatrix  *matrix,
+    BlockMatrix *matrix,
     const unsigned int  row,
     const unsigned int  col)
     :
@@ -2118,7 +2118,7 @@ inline
 void
 BlockMatrixBase<MatrixType>::add (const unsigned int   row,
                                   const unsigned int   n_cols,
-                                  const unsigned int  *col_indices,
+                                  const unsigned int *col_indices,
                                   const number        *values,
                                   const bool           elide_zero_values,
                                   const bool           col_indices_are_sorted)
@@ -2427,7 +2427,7 @@ template <class BlockVectorType,
          class VectorType>
 void
 BlockMatrixBase<MatrixType>::
-vmult_block_nonblock (BlockVectorType  &dst,
+vmult_block_nonblock (BlockVectorType &dst,
                       const VectorType &src) const
 {
   Assert (dst.n_blocks() == n_block_rows(),
@@ -2512,7 +2512,7 @@ template <class BlockVectorType,
          class VectorType>
 void
 BlockMatrixBase<MatrixType>::
-Tvmult_block_nonblock (BlockVectorType  &dst,
+Tvmult_block_nonblock (BlockVectorType &dst,
                        const VectorType &src) const
 {
   Assert (dst.n_blocks() == n_block_cols(),
index e2eb43ef722fa8bdfa2fc85d03beafafb81875fb..eb447518662cc56a09642bf4eb1e3c04e67331f8 100644 (file)
@@ -793,7 +793,7 @@ inline
 void
 MatrixBlock<MATRIX>::add (const unsigned int   b_row,
                           const unsigned int   n_cols,
-                          const unsigned int  *col_indices,
+                          const unsigned int *col_indices,
                           const number        *values,
                           const bool,
                           const bool)
index e1c53ceb3298a97cb48968af8c15f683a1d713ec..d16f47870dd25f2a5730b24b8127d878aabe0fe9 100644 (file)
@@ -254,7 +254,7 @@ namespace parallel
        * in_vector, and copies all the data.
        */
       Vector<Number> &
-      operator = (const Vector<Number>  &in_vector);
+      operator = (const Vector<Number> &in_vector);
 
       /**
        * Assigns the vector to the parallel
@@ -654,7 +654,7 @@ namespace parallel
        */
       template <typename OtherNumber>
       void add (const std::vector<unsigned int> &indices,
-                const std::vector<OtherNumber>  &values);
+                const std::vector<OtherNumber> &values);
 
       /**
        * This is a second collective
@@ -679,7 +679,7 @@ namespace parallel
       template <typename OtherNumber>
       void add (const unsigned int  n_elements,
                 const unsigned int *indices,
-                const OtherNumber  *values);
+                const OtherNumber *values);
 
       /**
        * Addition of @p s to all
@@ -1537,7 +1537,7 @@ namespace parallel
     inline
     void
     Vector<Number>::add (const std::vector<unsigned int> &indices,
-                         const std::vector<OtherNumber>  &values)
+                         const std::vector<OtherNumber> &values)
     {
       AssertDimension (indices.size(), values.size());
       add (indices.size(), &indices[0], &values[0]);
@@ -1564,7 +1564,7 @@ namespace parallel
     void
     Vector<Number>::add (const unsigned int  n_indices,
                          const unsigned int *indices,
-                         const OtherNumber  *values)
+                         const OtherNumber *values)
     {
       for (unsigned int i=0; i<n_indices; ++i)
         {
index c703fcd1cf827e5c27001dddfff4f41f0c70158c..35d21d195116caa4540853b51455cf01d8d63382 100644 (file)
@@ -239,7 +239,7 @@ namespace PETScWrappers
      * applicable if the matrix has
      * only one block row.
      */
-    void Tvmult (BlockVector  &dst,
+    void Tvmult (BlockVector &dst,
                  const Vector &src) const;
 
     /**
@@ -323,7 +323,7 @@ namespace PETScWrappers
 
   inline
   void
-  BlockSparseMatrix::vmult (BlockVector  &dst,
+  BlockSparseMatrix::vmult (BlockVector &dst,
                             const Vector &src) const
   {
     BaseClass::vmult_block_nonblock (dst, src);
@@ -362,7 +362,7 @@ namespace PETScWrappers
 
   inline
   void
-  BlockSparseMatrix::Tvmult (BlockVector  &dst,
+  BlockSparseMatrix::Tvmult (BlockVector &dst,
                              const Vector &src) const
   {
     BaseClass::Tvmult_block_nonblock (dst, src);
index 8847069092ed5555e98c3bd5551a671f96cad732..07ea7dd923e8d08c5939a4470c759dc54e911384 100644 (file)
@@ -98,7 +98,7 @@ namespace PETScWrappers
      * that of V, all components are copied
      * from V
      */
-    BlockVector (const BlockVector  &V);
+    BlockVector (const BlockVector &V);
 
     /**
      * Copy-constructor: copy the values
index 0274dd372b4f272b2d37a22e75a7a61babd48152..92bb6151c42e602ad0b6d3bd3ceb6d2a1928e158 100644 (file)
@@ -228,7 +228,7 @@ namespace PETScWrappers
        * applicable if the matrix has
        * only one block row.
        */
-      void Tvmult (BlockVector  &dst,
+      void Tvmult (BlockVector &dst,
                    const Vector &src) const;
 
       /**
@@ -313,7 +313,7 @@ namespace PETScWrappers
 
     inline
     void
-    BlockSparseMatrix::vmult (BlockVector  &dst,
+    BlockSparseMatrix::vmult (BlockVector &dst,
                               const Vector &src) const
     {
       BaseClass::vmult_block_nonblock (dst, src);
@@ -352,7 +352,7 @@ namespace PETScWrappers
 
     inline
     void
-    BlockSparseMatrix::Tvmult (BlockVector  &dst,
+    BlockSparseMatrix::Tvmult (BlockVector &dst,
                                const Vector &src) const
     {
       BaseClass::Tvmult_block_nonblock (dst, src);
index add3c011084623a5b5994703b42e44a6af36bb81..9092530630d276188d6485fcd872cb3cc43cd90b 100644 (file)
@@ -490,7 +490,7 @@ public:
    * not provide for nonzero entries on the entire diagonal.
    */
   SparseMatrix (const SparsityPattern &sparsity,
-                const IdentityMatrix  &id);
+                const IdentityMatrix &id);
 
   /**
    * Destructor. Free all memory, but do not release the memory of the
@@ -516,7 +516,7 @@ public:
    * provide for nonzero entries on the entire diagonal.
    */
   SparseMatrix<number> &
-  operator= (const IdentityMatrix  &id);
+  operator= (const IdentityMatrix &id);
 
   /**
    * This operator assigns a scalar to a matrix. Since this does usually not
index 5c13c278e0a3e4d85157a750afcafc4e68f608a1..fe87da3f19aa9e2ca5ab68655ccd57e9bb229187 100644 (file)
@@ -404,7 +404,7 @@ public:
    * matrix structure.  It must be compressed. The matrix structure is not
    * compressed after this function finishes.
    */
-  SparsityPattern (const SparsityPattern  &original,
+  SparsityPattern (const SparsityPattern &original,
                    const unsigned int      max_per_row,
                    const unsigned int      extra_off_diagonals);
 
index b49b57eb6cab0a95df902107fbaa65f983a46bb0..0680b3c883f92efaa126f687438e99cb737dd2c5 100644 (file)
@@ -318,7 +318,7 @@ namespace TrilinosWrappers
      * applicable if the matrix has
      * only one block column.
      */
-    void vmult (MPI::BlockVector  &dst,
+    void vmult (MPI::BlockVector &dst,
                 const MPI::Vector &src) const;
 
     /**
@@ -331,7 +331,7 @@ namespace TrilinosWrappers
      * (works only when run on one
      * processor).
      */
-    void vmult (BlockVector  &dst,
+    void vmult (BlockVector &dst,
                 const Vector &src) const;
 
     /**
@@ -399,7 +399,7 @@ namespace TrilinosWrappers
      * applicable if the matrix has
      * only one block row.
      */
-    void Tvmult (MPI::BlockVector  &dst,
+    void Tvmult (MPI::BlockVector &dst,
                  const MPI::Vector &src) const;
 
     /**
@@ -412,7 +412,7 @@ namespace TrilinosWrappers
      * vectors (works only when run
      * on one processor).
      */
-    void Tvmult (BlockVector  &dst,
+    void Tvmult (BlockVector &dst,
                  const Vector &src) const;
 
     /**
@@ -688,7 +688,7 @@ namespace TrilinosWrappers
 
   inline
   void
-  BlockSparseMatrix::vmult (MPI::BlockVector  &dst,
+  BlockSparseMatrix::vmult (MPI::BlockVector &dst,
                             const MPI::Vector &src) const
   {
     BaseClass::vmult_block_nonblock (dst, src);
@@ -698,7 +698,7 @@ namespace TrilinosWrappers
 
   inline
   void
-  BlockSparseMatrix::vmult (BlockVector  &dst,
+  BlockSparseMatrix::vmult (BlockVector &dst,
                             const Vector &src) const
   {
     BaseClass::vmult_block_nonblock (dst, src);
@@ -758,7 +758,7 @@ namespace TrilinosWrappers
 
   inline
   void
-  BlockSparseMatrix::Tvmult (MPI::BlockVector  &dst,
+  BlockSparseMatrix::Tvmult (MPI::BlockVector &dst,
                              const MPI::Vector &src) const
   {
     BaseClass::Tvmult_block_nonblock (dst, src);
@@ -768,7 +768,7 @@ namespace TrilinosWrappers
 
   inline
   void
-  BlockSparseMatrix::Tvmult (BlockVector  &dst,
+  BlockSparseMatrix::Tvmult (BlockVector &dst,
                              const Vector &src) const
   {
     BaseClass::Tvmult_block_nonblock (dst, src);
index 76bee846341d47a6318c303703e14627ecdfdaa0..6e386f86bf942ef87c5a796da97bbd33e6e32e68 100644 (file)
@@ -644,7 +644,7 @@ namespace TrilinosWrappers
      * values in the second.
      */
     void set (const std::vector<unsigned int>    &indices,
-              const std::vector<TrilinosScalar>  &values);
+              const std::vector<TrilinosScalar> &values);
 
     /**
      * This is a second collective
@@ -1312,7 +1312,7 @@ namespace TrilinosWrappers
   inline
   void
   VectorBase::set (const std::vector<unsigned int>    &indices,
-                   const std::vector<TrilinosScalar>  &values)
+                   const std::vector<TrilinosScalar> &values)
   {
     // if we have ghost values, do not allow
     // writing to this vector at all.
@@ -1381,7 +1381,7 @@ namespace TrilinosWrappers
   inline
   void
   VectorBase::add (const std::vector<unsigned int>    &indices,
-                   const std::vector<TrilinosScalar>  &values)
+                   const std::vector<TrilinosScalar> &values)
   {
     // if we have ghost values, do not allow
     // writing to this vector at all.
index f4a65a839a96a52f010ebf5874965c4ace6fe22d..fccc27c794cfe825ed11499417187f3143e898ba 100644 (file)
@@ -700,7 +700,7 @@ public:
    */
   template <typename OtherNumber>
   void add (const std::vector<unsigned int> &indices,
-            const std::vector<OtherNumber>  &values);
+            const std::vector<OtherNumber> &values);
 
   /**
    * This is a second collective
@@ -725,7 +725,7 @@ public:
   template <typename OtherNumber>
   void add (const unsigned int  n_elements,
             const unsigned int *indices,
-            const OtherNumber  *values);
+            const OtherNumber *values);
 
   /**
    * Addition of @p s to all
@@ -1297,7 +1297,7 @@ template <typename OtherNumber>
 inline
 void
 Vector<Number>::add (const std::vector<unsigned int> &indices,
-                     const std::vector<OtherNumber>  &values)
+                     const std::vector<OtherNumber> &values)
 {
   Assert (indices.size() == values.size(),
           ExcDimensionMismatch(indices.size(), values.size()));
@@ -1326,7 +1326,7 @@ inline
 void
 Vector<Number>::add (const unsigned int  n_indices,
                      const unsigned int *indices,
-                     const OtherNumber  *values)
+                     const OtherNumber *values)
 {
   for (unsigned int i=0; i<n_indices; ++i)
     {
index 3b315b3b4835b1c3339b87db45a42aedcbc42308..8164f470486e0ae22bc447230d603d329035a59c 100644 (file)
@@ -2280,7 +2280,7 @@ template<typename VectorType>
 inline
 void
 FEEvaluationBase<dim,dofs_per_cell_,n_q_points_,n_components_,Number>
-::distribute_local_to_global (std::vector<VectorType>  &dst,
+::distribute_local_to_global (std::vector<VectorType> &dst,
                               const unsigned int        first_index) const
 {
   AssertIndexRange (first_index, dst.size());
@@ -2307,7 +2307,7 @@ template<typename VectorType>
 inline
 void
 FEEvaluationBase<dim,dofs_per_cell_,n_q_points_,n_components_,Number>
-::distribute_local_to_global (std::vector<VectorType *>  &dst,
+::distribute_local_to_global (std::vector<VectorType *> &dst,
                               const unsigned int         first_index) const
 {
   AssertIndexRange (first_index, dst.size());
@@ -2358,7 +2358,7 @@ template<typename VectorType>
 inline
 void
 FEEvaluationBase<dim,dofs_per_cell_,n_q_points_,n_components_,Number>
-::set_dof_values (std::vector<VectorType>  &dst,
+::set_dof_values (std::vector<VectorType> &dst,
                   const unsigned int        first_index) const
 {
   AssertIndexRange (first_index, dst.size());
@@ -2386,7 +2386,7 @@ template<typename VectorType>
 inline
 void
 FEEvaluationBase<dim,dofs_per_cell_,n_q_points_,n_components_,Number>
-::set_dof_values (std::vector<VectorType *>  &dst,
+::set_dof_values (std::vector<VectorType *> &dst,
                   const unsigned int         first_index) const
 {
   AssertIndexRange (first_index, dst.size());
index bfd47e83c0c925cbc4999d87480be2c7f208246b..6a46b630fffd3a3930c7873472397fa2c7c21b0c 100644 (file)
@@ -77,7 +77,7 @@ namespace internal
                        const std::vector<std::pair<unsigned int,unsigned int> > &cells,
                        const std::vector<unsigned int>         &active_fe_index,
                        const Mapping<dim>                      &mapping,
-                       const std::vector<dealii::hp::QCollection<1> >  &quad,
+                       const std::vector<dealii::hp::QCollection<1> > &quad,
                        const UpdateFlags                        update_flags);
 
       /**
@@ -88,7 +88,7 @@ namespace internal
        */
       UpdateFlags
       compute_update_flags (const UpdateFlags                        update_flags,
-                            const std::vector<dealii::hp::QCollection<1> >  &quad) const;
+                            const std::vector<dealii::hp::QCollection<1> > &quad) const;
 
       /**
        * Returns the type of a given cell as
index a57459f2dbf81e965e8f0581dedd9bc2291c3ff1..e81efbf21f9523ffaac251c7a6fd2483ae2c19b6 100644 (file)
@@ -740,8 +740,8 @@ namespace MeshWorker
 
         if (pc != 0)
           fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
-                        new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
-                                                pc->get_quadrature(), pc->get_update_flags()));
+                          new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
+                                                  pc->get_quadrature(), pc->get_update_flags()));
         else if (pf != 0)
           fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
                         new FEFaceValues<dim,sdim> (pf->get_mapping(), pf->get_fe(), pf->get_quadrature(), pf->get_update_flags()));
@@ -778,8 +778,8 @@ namespace MeshWorker
 
         if (pc != 0)
           fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
-                        new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
-                                                pc->get_quadrature(), pc->get_update_flags()));
+                          new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
+                                                  pc->get_quadrature(), pc->get_update_flags()));
         else if (pf != 0)
           {
             Assert (false, ExcImpossibleInDim(1));
@@ -820,8 +820,8 @@ namespace MeshWorker
 
         if (pc != 0)
           fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
-                        new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
-                                                pc->get_quadrature(), pc->get_update_flags()));
+                          new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
+                                                  pc->get_quadrature(), pc->get_update_flags()));
         else if (pf != 0)
           {
             Assert (false, ExcImpossibleInDim(1));
index fc31e5e29e9021b341f8ee22625cadcade04bb34..8cfc4eb7d2c300a07261ac25be13fc37409c5ed4 100644 (file)
@@ -208,7 +208,7 @@ template<class SOLVER, class VECTOR>
 template<class MATRIX, class PRECOND>
 MGCoarseGridLACIteration<SOLVER, VECTOR>
 ::MGCoarseGridLACIteration(SOLVER &s,
-                           const MATRIX  &m,
+                           const MATRIX &m,
                            const PRECOND &p)
   :
   solver(&s, typeid(*this).name())
@@ -231,7 +231,7 @@ template<class MATRIX, class PRECOND>
 void
 MGCoarseGridLACIteration<SOLVER, VECTOR>
 ::initialize(SOLVER &s,
-             const MATRIX  &m,
+             const MATRIX &m,
              const PRECOND &p)
 {
   solver = &s;
index 0aaa4cc2c53cf1d887cb588bf514ba09026bab86..2958010bd1c7052423e4b8f246c3c57e8ba5ee93 100644 (file)
@@ -380,7 +380,7 @@ private:
      */
     template <class InputVector, int spacedim>
     static ProjectedDerivative
-    get_projected_derivative (const FEValues<dim,spacedim>  &fe_values,
+    get_projected_derivative (const FEValues<dim,spacedim> &fe_values,
                               const InputVector    &solution,
                               const unsigned int    component);
 
@@ -461,7 +461,7 @@ private:
      */
     template <class InputVector, int spacedim>
     static ProjectedDerivative
-    get_projected_derivative (const FEValues<dim,spacedim>  &fe_values,
+    get_projected_derivative (const FEValues<dim,spacedim> &fe_values,
                               const InputVector    &solution,
                               const unsigned int    component);
 
@@ -539,7 +539,7 @@ private:
      */
     template <class InputVector, int spacedim>
     static ProjectedDerivative
-    get_projected_derivative (const FEValues<dim,spacedim>  &fe_values,
+    get_projected_derivative (const FEValues<dim,spacedim> &fe_values,
                               const InputVector    &solution,
                               const unsigned int    component);
 
@@ -690,7 +690,7 @@ private:
                     const DH<dim,spacedim>                                 &dof,
                     const InputVector                             &solution,
                     const unsigned int                             component,
-                    const typename DH<dim,spacedim>::active_cell_iterator  &cell,
+                    const typename DH<dim,spacedim>::active_cell_iterator &cell,
                     typename DerivativeDescription::Derivative    &derivative);
 };
 
index 5bdce1a2d1c710ac455b4df88ddb360b6ab30741..a17ce5ae7002eeffabe93080a0413983a9522a5e 100644 (file)
@@ -603,7 +603,7 @@ public:
    * general case.
    */
   template <typename InputVector, class DH>
-  static void estimate (const Mapping<1,spacedim>  &mapping,
+  static void estimate (const Mapping<1,spacedim> &mapping,
                         const DH   &dof,
                         const Quadrature<0> &quadrature,
                         const typename FunctionMap<spacedim>::type &neumann_bc,
index 980235f1e8a8915524101fb55036e6de0f67ae52..a34eec00b157d08ffeebd603141724d7e34054a5 100644 (file)
@@ -806,7 +806,7 @@ namespace MatrixTools
   template <typename number>
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         SparseMatrix<number>  &matrix,
+                         SparseMatrix<number> &matrix,
                          Vector<number>        &solution,
                          Vector<number>        &right_hand_side,
                          const bool             eliminate_columns = true);
@@ -868,9 +868,9 @@ namespace MatrixTools
    */
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         PETScWrappers::SparseMatrix  &matrix,
-                         PETScWrappers::Vector  &solution,
-                         PETScWrappers::Vector  &right_hand_side,
+                         PETScWrappers::SparseMatrix &matrix,
+                         PETScWrappers::Vector &solution,
+                         PETScWrappers::Vector &right_hand_side,
                          const bool             eliminate_columns = true);
 
   /**
@@ -879,9 +879,9 @@ namespace MatrixTools
    */
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         PETScWrappers::MPI::SparseMatrix  &matrix,
-                         PETScWrappers::MPI::Vector  &solution,
-                         PETScWrappers::MPI::Vector  &right_hand_side,
+                         PETScWrappers::MPI::SparseMatrix &matrix,
+                         PETScWrappers::MPI::Vector &solution,
+                         PETScWrappers::MPI::Vector &right_hand_side,
                          const bool             eliminate_columns = true);
 
   /**
@@ -911,17 +911,17 @@ namespace MatrixTools
    */
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         PETScWrappers::MPI::SparseMatrix  &matrix,
+                         PETScWrappers::MPI::SparseMatrix &matrix,
                          PETScWrappers::Vector       &solution,
-                         PETScWrappers::MPI::Vector  &right_hand_side,
+                         PETScWrappers::MPI::Vector &right_hand_side,
                          const bool             eliminate_columns = true);
 
   /**
    * Same as above but for BlockSparseMatrix.
    */
   void
-  apply_boundary_values (const std::map<unsigned int,double>  &boundary_values,
-                         PETScWrappers::MPI::BlockSparseMatrix  &matrix,
+  apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
+                         PETScWrappers::MPI::BlockSparseMatrix &matrix,
                          PETScWrappers::MPI::BlockVector        &solution,
                          PETScWrappers::MPI::BlockVector        &right_hand_side,
                          const bool       eliminate_columns = true);
@@ -969,7 +969,7 @@ namespace MatrixTools
    */
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         TrilinosWrappers::SparseMatrix  &matrix,
+                         TrilinosWrappers::SparseMatrix &matrix,
                          TrilinosWrappers::Vector        &solution,
                          TrilinosWrappers::Vector        &right_hand_side,
                          const bool             eliminate_columns = true);
@@ -981,7 +981,7 @@ namespace MatrixTools
    */
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         TrilinosWrappers::BlockSparseMatrix  &matrix,
+                         TrilinosWrappers::BlockSparseMatrix &matrix,
                          TrilinosWrappers::BlockVector        &solution,
                          TrilinosWrappers::BlockVector        &right_hand_side,
                          const bool                eliminate_columns = true);
@@ -1024,7 +1024,7 @@ namespace MatrixTools
    */
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         TrilinosWrappers::SparseMatrix  &matrix,
+                         TrilinosWrappers::SparseMatrix &matrix,
                          TrilinosWrappers::MPI::Vector   &solution,
                          TrilinosWrappers::MPI::Vector   &right_hand_side,
                          const bool             eliminate_columns = true);
@@ -1036,7 +1036,7 @@ namespace MatrixTools
    */
   void
   apply_boundary_values (const std::map<unsigned int,double> &boundary_values,
-                         TrilinosWrappers::BlockSparseMatrix  &matrix,
+                         TrilinosWrappers::BlockSparseMatrix &matrix,
                          TrilinosWrappers::MPI::BlockVector   &solution,
                          TrilinosWrappers::MPI::BlockVector   &right_hand_side,
                          const bool                eliminate_columns = true);
index ba3ef871d6629661a5d9310b1da66bedf63d6c91..1f2160480ad2eb9a3749cc0360b3d1427aea2edd 100644 (file)
@@ -574,7 +574,7 @@ namespace VectorTools
   interpolate_to_different_mesh (const DH<dim, spacedim> &dof1,
                                  const VECTOR            &u1,
                                  const DH<dim, spacedim> &dof2,
-                                 const ConstraintMatrix  &constraints,
+                                 const ConstraintMatrix &constraints,
                                  VECTOR                  &u2);
 
 
index cb91da685c08e11242fca782d3768914910d7ac7..a96dfb3a24072e4ad9a769b6ff2ad5ac77d29d20 100644 (file)
@@ -479,7 +479,7 @@ namespace VectorTools
   interpolate_to_different_mesh (const DH<dim, spacedim> &dof1,
                                  const Vector            &u1,
                                  const DH<dim, spacedim> &dof2,
-                                 const ConstraintMatrix  &constraints,
+                                 const ConstraintMatrix &constraints,
                                  Vector                  &u2)
   {
     Assert(GridTools::have_same_coarse_mesh(dof1, dof2),
@@ -2109,7 +2109,7 @@ namespace VectorTools
                            const DoFHandler<dim, spacedim> &dof,
                            const typename FunctionMap<spacedim>::type &boundary_functions,
                            const Quadrature<dim-1>        &q,
-                           std::map<unsigned int,double>  &boundary_values,
+                           std::map<unsigned int,double> &boundary_values,
                            std::vector<unsigned int>       component_mapping)
   {
 //TODO:[?] In project_boundary_values, no condensation of sparsity

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.