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

15 files changed:
deal.II/include/deal.II/dofs/dof_handler_policy.h
deal.II/include/deal.II/dofs/dof_renumbering.h
deal.II/include/deal.II/dofs/dof_tools.h
deal.II/include/deal.II/fe/fe_values.h
deal.II/include/deal.II/hp/dof_handler.h
deal.II/include/deal.II/hp/fe_values.h
deal.II/include/deal.II/matrix_free/matrix_free.h
deal.II/include/deal.II/multigrid/mg_dof_handler.h
deal.II/include/deal.II/multigrid/mg_tools.h
deal.II/source/dofs/dof_handler_policy.cc
deal.II/source/dofs/dof_renumbering.inst.in
deal.II/source/dofs/dof_tools.cc
deal.II/source/fe/mapping_q1_eulerian.cc
deal.II/source/hp/fe_values.cc
deal.II/source/lac/trilinos_sparse_matrix.cc

index bd3627de3a47bde33b7fc662df622c4bcc14f9b8..2fbbcc7becacd599cd4a1d0843fbfc5f754933a5 100644 (file)
@@ -81,7 +81,7 @@ namespace internal
          */
         virtual
         NumberCache
-        renumber_dofs (const std::vector<unsigned int>  &new_numbers,
+        renumber_dofs (const std::vector<unsigned int> &new_numbers,
                        dealii::DoFHandler<dim,spacedim> &dof_handler) const = 0;
       };
 
@@ -118,7 +118,7 @@ namespace internal
          */
         virtual
         NumberCache
-        renumber_dofs (const std::vector<unsigned int>  &new_numbers,
+        renumber_dofs (const std::vector<unsigned int> &new_numbers,
                        dealii::DoFHandler<dim,spacedim> &dof_handler) const;
       };
 
@@ -156,7 +156,7 @@ namespace internal
          */
         virtual
         NumberCache
-        renumber_dofs (const std::vector<unsigned int>  &new_numbers,
+        renumber_dofs (const std::vector<unsigned int> &new_numbers,
                        dealii::DoFHandler<dim,spacedim> &dof_handler) const;
       };
     }
index b0431b59e296f57a203e81ca14de2d04eab6a077..93c3c1b8c7298acb2fb4c910d66a79f768b9ed5a 100644 (file)
@@ -891,7 +891,7 @@ namespace DoFRenumbering
    */
   template <int dim>
   void
-  block_wise (MGDoFHandler<dim>  &dof_handler,
+  block_wise (MGDoFHandler<dim> &dof_handler,
               const unsigned int  level);
 
 
index 489358a97668ed9687c33db8f6d330bce60cc027..432b04b2b8ff07aea015d42024d94b27eb97cf34 100644 (file)
@@ -1283,7 +1283,7 @@ namespace DoFTools
   template <class DH, typename Number>
   void
   distribute_cell_to_dof_vector (const DH              &dof_handler,
-                                 const Vector<Number>  &cell_data,
+                                 const Vector<Number> &cell_data,
                                  Vector<double>        &dof_data,
                                  const unsigned int     component = 0);
 
@@ -1610,7 +1610,7 @@ namespace DoFTools
   void
   extract_subdomain_dofs (const DH           &dof_handler,
                           const types::subdomain_id subdomain_id,
-                          std::vector<bool>  &selected_dofs);
+                          std::vector<bool> &selected_dofs);
 
 
   /**
@@ -2283,7 +2283,7 @@ namespace DoFTools
   void
   count_dofs_per_block (const DH &dof,
                         std::vector<unsigned int> &dofs_per_block,
-                        const std::vector<unsigned int>  &target_block
+                        const std::vector<unsigned int> &target_block
                         = std::vector<unsigned int>());
 
   /**
@@ -2586,7 +2586,7 @@ namespace DoFTools
   template <class DH>
   void
   map_dof_to_boundary_indices (const DH                   &dof_handler,
-                               std::vector<unsigned int>  &mapping);
+                               std::vector<unsigned int> &mapping);
 
   /**
    * Same as the previous function,
index 708250c034f2b6ce60bb5f8e5108e67f2492c0fd..33a8e9b5434d64485f074779dd4ce92fb5186a54 100644 (file)
@@ -4091,11 +4091,11 @@ namespace FEValuesViews
   namespace
   {
     /**
-    * Return the symmetrized version of a
-    * tensor whose n'th row equals the
-    * second argument, with all other rows
-    * equal to zero.
-    */
+     * Return the symmetrized version of a
+     * tensor whose n'th row equals the
+     * second argument, with all other rows
+     * equal to zero.
+     */
     inline
     dealii::SymmetricTensor<2,1>
     symmetrize_single_row (const unsigned int n,
index 9f4ed86563f68224ee9360d07ea2dd93d9392aaa..32fbed9f026dfbd41886c0873fd3558a1a8f7f72 100644 (file)
@@ -293,8 +293,8 @@ namespace hp
     unsigned int max_couplings_between_boundary_dofs () const;
 
     /**
-     *  @name Cell iterator functions
-     */
+    *  @name Cell iterator functions
+    */
     /*@{*/
     /**
     * Iterator to the first used
index 51377aba2d5a009a6c1f6379cb25a8c7c72c3113..eb886a0c44ac85c39bcddda18f45abe176a284b4 100644 (file)
@@ -59,64 +59,64 @@ namespace internal
     {
     public:
       /**
-      * Constructor. Set the fields
-      * of this class to the values
-      * indicated by the parameters
-      * to the constructor.
-      */
+       * Constructor. Set the fields
+       * of this class to the values
+       * indicated by the parameters
+       * to the constructor.
+       */
       FEValuesBase (const dealii::hp::MappingCollection<dim,FEValues::space_dimension> &mapping_collection,
                     const dealii::hp::FECollection<dim,FEValues::space_dimension>      &fe_collection,
                     const dealii::hp::QCollection<q_dim>     &q_collection,
                     const UpdateFlags             update_flags);
       /**
-      * Constructor. Set the fields
-      * of this class to the values
-      * indicated by the parameters
-      * to the constructor, and
-      * choose a @p MappingQ1
-      * object for the mapping
-      * object.
-      */
+       * Constructor. Set the fields
+       * of this class to the values
+       * indicated by the parameters
+       * to the constructor, and
+       * choose a @p MappingQ1
+       * object for the mapping
+       * object.
+       */
       FEValuesBase (const dealii::hp::FECollection<dim,FEValues::space_dimension> &fe_collection,
                     const dealii::hp::QCollection<q_dim> &q_collection,
                     const UpdateFlags         update_flags);
 
       /**
-      * Get a reference to the
-      * collection of finite
-      * element objects used here.
-      */
+       * Get a reference to the
+       * collection of finite
+       * element objects used here.
+       */
       const dealii::hp::FECollection<dim,FEValues::space_dimension> &
       get_fe_collection () const;
 
       /**
-      * Return a reference to the @p
-      * FEValues object selected by the
-      * last call to
-      * select_fe_values(). select_fe_values()
-      * in turn is called when you called
-      * the @p reinit function of the
-      * <tt>hp::FE*Values</tt> class the
-      * last time.
-      */
+       * Return a reference to the @p
+       * FEValues object selected by the
+       * last call to
+       * select_fe_values(). select_fe_values()
+       * in turn is called when you called
+       * the @p reinit function of the
+       * <tt>hp::FE*Values</tt> class the
+       * last time.
+       */
       const FEValues &get_present_fe_values () const;
 
     protected:
 
       /**
-      * Select a FEValues object
-      * suitable for the given FE,
-      * quadrature, and mapping
-      * indices. If such an object
-      * doesn't yet exist, create
-      * one.
-      *
-      * The function returns a
-      * writable reference so that
-      * derived classes can also
-      * reinit() the selected
-      * FEValues object.
-      */
+       * Select a FEValues object
+       * suitable for the given FE,
+       * quadrature, and mapping
+       * indices. If such an object
+       * doesn't yet exist, create
+       * one.
+       *
+       * The function returns a
+       * writable reference so that
+       * derived classes can also
+       * reinit() the selected
+       * FEValues object.
+       */
       FEValues &
       select_fe_values (const unsigned int fe_index,
                         const unsigned int mapping_index,
@@ -124,69 +124,69 @@ namespace internal
 
     protected:
       /**
-      * A pointer to the
-      * collection of finite
-      * elements to be used.
-      */
+       * A pointer to the
+       * collection of finite
+       * elements to be used.
+       */
       const SmartPointer<const dealii::hp::FECollection<dim,FEValues::space_dimension>,
             FEValuesBase<dim,q_dim,FEValues> > fe_collection;
 
       /**
-      * A pointer to the
-      * collection of mappings to
-      * be used.
-      */
+       * A pointer to the
+       * collection of mappings to
+       * be used.
+       */
       const SmartPointer<const dealii::hp::MappingCollection<dim, FEValues::space_dimension>,
             FEValuesBase<dim,q_dim,FEValues> > mapping_collection;
 
       /**
-      * Copy of the quadrature
-      * collection object
-      * provided to the
-      * constructor.
-      */
+       * Copy of the quadrature
+       * collection object
+       * provided to the
+       * constructor.
+       */
       const dealii::hp::QCollection<q_dim> q_collection;
 
     private:
       /**
-      * A table in which we store
-      * pointers to fe_values
-      * objects for different
-      * finite element, mapping,
-      * and quadrature objects
-      * from our collection. The
-      * first index indicates the
-      * index of the finite
-      * element within the
-      * fe_collection, the second
-      * the index of the mapping
-      * within the mapping
-      * collection, and the last
-      * one the index of the
-      * quadrature formula within
-      * the q_collection.
-      *
-      * Initially, all entries
-      * have zero pointers, and we
-      * will allocate them lazily
-      * as needed in
-      * select_fe_values().
-      */
+       * A table in which we store
+       * pointers to fe_values
+       * objects for different
+       * finite element, mapping,
+       * and quadrature objects
+       * from our collection. The
+       * first index indicates the
+       * index of the finite
+       * element within the
+       * fe_collection, the second
+       * the index of the mapping
+       * within the mapping
+       * collection, and the last
+       * one the index of the
+       * quadrature formula within
+       * the q_collection.
+       *
+       * Initially, all entries
+       * have zero pointers, and we
+       * will allocate them lazily
+       * as needed in
+       * select_fe_values().
+       */
       Table<3,std_cxx1x::shared_ptr<FEValues> > fe_values_table;
 
       /**
-      * Set of indices pointing at
-      * the fe_values object
-      * selected last time the
-      * select_fe_value() function
-      * was called.
-      */
+       * Set of indices pointing at
+       * the fe_values object
+       * selected last time the
+       * select_fe_value() function
+       * was called.
+       */
       TableIndices<3> present_fe_values_index;
 
       /**
-      * Values of the update flags as
-      * given to the constructor.
-      */
+       * Values of the update flags as
+       * given to the constructor.
+       */
       const UpdateFlags update_flags;
     };
 
@@ -274,7 +274,7 @@ namespace hp
      * function.
      */
     FEValues (const dealii::hp::MappingCollection<dim,spacedim> &mapping_collection,
-              const dealii::hp::FECollection<dim,spacedim>  &fe_collection,
+              const dealii::hp::FECollection<dim,spacedim> &fe_collection,
               const dealii::hp::QCollection<dim>       &q_collection,
               const UpdateFlags             update_flags);
 
@@ -501,7 +501,7 @@ namespace hp
      * function.
      */
     FEFaceValues (const hp::MappingCollection<dim,spacedim> &mapping_collection,
-                  const hp::FECollection<dim,spacedim>  &fe_collection,
+                  const hp::FECollection<dim,spacedim> &fe_collection,
                   const hp::QCollection<dim-1>     &q_collection,
                   const UpdateFlags             update_flags);
 
@@ -528,7 +528,7 @@ namespace hp
      * <tt>DoFHandler::get_fe()</tt>
      * function.
      */
-    FEFaceValues (const hp::FECollection<dim,spacedim>  &fe_collection,
+    FEFaceValues (const hp::FECollection<dim,spacedim> &fe_collection,
                   const hp::QCollection<dim-1> &q_collection,
                   const UpdateFlags             update_flags);
 
@@ -711,7 +711,7 @@ namespace hp
      * function.
      */
     FESubfaceValues (const hp::MappingCollection<dim,spacedim> &mapping_collection,
-                     const hp::FECollection<dim,spacedim>  &fe_collection,
+                     const hp::FECollection<dim,spacedim> &fe_collection,
                      const hp::QCollection<dim-1>     &q_collection,
                      const UpdateFlags             update_flags);
 
index c5b8ea394bc8dc9212c8194dd4d7d6c5b28c082f..0b86a9bb42453dbe8eb4bf41764a93ade4622298 100644 (file)
@@ -1925,7 +1925,7 @@ template <int dim, typename Number>
 template <typename DH, typename Quad>
 void MatrixFree<dim,Number>::
 reinit(const Mapping<dim>                         &mapping,
-       const std::vector<const DH *>  &dof_handler,
+       const std::vector<const DH *> &dof_handler,
        const std::vector<const ConstraintMatrix *> &constraint,
        const std::vector<Quad>              &quad,
        const MatrixFree<dim,Number>::AdditionalData additional_data)
@@ -1983,7 +1983,7 @@ namespace internal
 
   template<typename Number>
   inline
-  void update_ghost_values_start (const parallel::distributed::Vector<Number>  &src,
+  void update_ghost_values_start (const parallel::distributed::Vector<Number> &src,
                                   const unsigned int                  channel = 0)
   {
     src.update_ghost_values_start(channel);
@@ -1993,7 +1993,7 @@ namespace internal
 
   template <typename VectorStruct>
   inline
-  void update_ghost_values_start (const std::vector<VectorStruct>  &src)
+  void update_ghost_values_start (const std::vector<VectorStruct> &src)
   {
     for (unsigned int comp=0; comp<src.size(); comp++)
       update_ghost_values_start(src[comp], comp);
@@ -2003,7 +2003,7 @@ namespace internal
 
   template <typename VectorStruct>
   inline
-  void update_ghost_values_start (const std::vector<VectorStruct *>  &src)
+  void update_ghost_values_start (const std::vector<VectorStruct *> &src)
   {
     for (unsigned int comp=0; comp<src.size(); comp++)
       update_ghost_values_start(*src[comp], comp);
@@ -2020,7 +2020,7 @@ namespace internal
 
   template <typename Number>
   inline
-  void update_ghost_values_finish (const parallel::distributed::Vector<Number>  &src)
+  void update_ghost_values_finish (const parallel::distributed::Vector<Number> &src)
   {
     src.update_ghost_values_finish();
   }
@@ -2029,7 +2029,7 @@ namespace internal
 
   template <typename VectorStruct>
   inline
-  void update_ghost_values_finish (const std::vector<VectorStruct>  &src)
+  void update_ghost_values_finish (const std::vector<VectorStruct> &src)
   {
     for (unsigned int comp=0; comp<src.size(); comp++)
       update_ghost_values_finish(src[comp]);
@@ -2039,7 +2039,7 @@ namespace internal
 
   template <typename VectorStruct>
   inline
-  void update_ghost_values_finish (const std::vector<VectorStruct *>  &src)
+  void update_ghost_values_finish (const std::vector<VectorStruct *> &src)
   {
     for (unsigned int comp=0; comp<src.size(); comp++)
       update_ghost_values_finish(*src[comp]);
@@ -2252,7 +2252,7 @@ namespace internal
       tbb::empty_task *dummy;
 
     private:
-      const Worker  &function;
+      const Worker &function;
       const unsigned int partition;
       const internal::MatrixFreeFunctions::TaskInfo &task_info;
     };
@@ -2338,7 +2338,7 @@ namespace internal
   class MPIComDistribute : public tbb::task
   {
   public:
-    MPIComDistribute (const VectorStruct  &src_in)
+    MPIComDistribute (const VectorStruct &src_in)
       :
       src(src_in)
     {};
@@ -2391,7 +2391,7 @@ MatrixFree<dim, Number>::cell_loop
                                  const std::pair<unsigned int,
                                  unsigned int> &)> &cell_operation,
  OutVector       &dst,
- const InVector  &src) const
+ const InVector &src) const
 {
 #if DEAL_II_USE_MT==1
 
index e7b872039f030693b4e4bc30c10757343bec9534..148dc9670aad0588469c0572d3d9d5c209dcd78d 100644 (file)
@@ -77,29 +77,29 @@ public:
   typedef typename IteratorSelector::active_face_iterator active_face_iterator;
 
   /**
-  * Make the dimension and the space_dimension available
-  * in function templates.
-  */
+   * Make the dimension and the space_dimension available
+   * in function templates.
+   */
   static const unsigned int dimension = dim;
 
   static const unsigned int space_dimension = spacedim;
 
   /**
-  * Default constructor, which
-  * will require a call to
-  * initialize() later to set the Triangulation.
-  */
+   * Default constructor, which
+   * will require a call to
+   * initialize() later to set the Triangulation.
+   */
   MGDoFHandler ();
 
   /**
-  * Constructor. Take @p tria as
-  * the triangulation to work on.
-  */
+   * Constructor. Take @p tria as
+   * the triangulation to work on.
+   */
   MGDoFHandler (const Triangulation<dim, spacedim> &tria);
 
   /**
-  * Destructor
-  */
+   * Destructor
+   */
   virtual ~MGDoFHandler ();
 
   /**
index e628e42b0b8d1b4cc2aa0032238a1de35f867de6..102d1d4e2e8c9c6c36403d23adfaaab8754801ee 100644 (file)
@@ -233,7 +233,7 @@ namespace MGTools
   void
   make_boundary_list (const DoFHandler<dim,spacedim>      &mg_dof,
                       const typename FunctionMap<dim>::type &function_map,
-                      std::vector<std::set<unsigned int> >  &boundary_indices,
+                      std::vector<std::set<unsigned int> > &boundary_indices,
                       const ComponentMask                   &component_mask = ComponentMask());
 
   /**
@@ -286,8 +286,8 @@ namespace MGTools
   template <int dim, int spacedim>
   void
   extract_inner_interface_dofs (const DoFHandler<dim,spacedim> &mg_dof_handler,
-                                std::vector<std::vector<bool> >  &interface_dofs,
-                                std::vector<std::vector<bool> >  &boundary_interface_dofs);
+                                std::vector<std::vector<bool> > &interface_dofs,
+                                std::vector<std::vector<bool> > &boundary_interface_dofs);
 
   /**
    * Does the same as the function above,
@@ -296,12 +296,12 @@ namespace MGTools
   template <int dim, int spacedim>
   void
   extract_inner_interface_dofs (const DoFHandler<dim,spacedim> &mg_dof_handler,
-                                std::vector<std::vector<bool> >  &interface_dofs);
+                                std::vector<std::vector<bool> > &interface_dofs);
 
   template <int dim, int spacedim>
   void
   extract_non_interface_dofs (const DoFHandler<dim,spacedim> &mg_dof_handler,
-                              std::vector<std::set<unsigned int> >  &non_interface_dofs);
+                              std::vector<std::set<unsigned int> > &non_interface_dofs);
 }
 
 /* @} */
index 9c9316f25674badb2a3dbb7ee32c5ff803e38346..49c11f4ac1307e96e2b9674848172695d663fc3b 100644 (file)
@@ -922,7 +922,7 @@ namespace internal
       template <int dim, int spacedim>
       NumberCache
       Sequential<dim,spacedim>::
-      renumber_dofs (const std::vector<unsigned int>  &new_numbers,
+      renumber_dofs (const std::vector<unsigned int> &new_numbers,
                      dealii::DoFHandler<dim,spacedim> &dof_handler) const
       {
         Implementation::renumber_dofs (new_numbers, IndexSet(0),
index 1c0c76951651dbef3ea762a631190cff776b8984..fcfc82d8433409f9616af5637bbfeca94f2c3f52 100644 (file)
@@ -140,7 +140,7 @@ namespace DoFRenumbering
        const bool,
        const bool,
        const std::vector<unsigned int>&);
-       
+
     template
       void component_wise
       (hp::DoFHandler<deal_II_dimension>&,
index 43234a5ab03b0e413744a1b7b4b7eee37d0e6bad..7139210eef9bde6739cee9b97eaf376ad45870e3 100644 (file)
@@ -117,7 +117,7 @@ namespace DoFTools
   make_sparsity_pattern (const DH                &dof,
                          const Table<2,Coupling> &couplings,
                          SparsityPattern         &sparsity,
-                         const ConstraintMatrix  &constraints,
+                         const ConstraintMatrix &constraints,
                          const bool               keep_constrained_dofs,
                          const types::subdomain_id subdomain_id)
   {
@@ -1781,8 +1781,8 @@ namespace DoFTools
 
 
     void
-    make_hp_hanging_node_constraints (const dealii::hp::DoFHandler<1> &/*dof_handler*/,
-                                      ConstraintMatrix        &/*constraints*/)
+    make_hp_hanging_node_constraints (const dealii::hp::DoFHandler<1> & /*dof_handler*/,
+                                      ConstraintMatrix &        /*constraints*/)
     {
       // we may have to compute constraints for vertices. gotta think about
       // that a bit more
@@ -1793,8 +1793,8 @@ namespace DoFTools
 
 
     void
-    make_oldstyle_hanging_node_constraints (const dealii::hp::DoFHandler<1> &/*dof_handler*/,
-                                            ConstraintMatrix        &/*constraints*/,
+    make_oldstyle_hanging_node_constraints (const dealii::hp::DoFHandler<1> & /*dof_handler*/,
+                                            ConstraintMatrix &        /*constraints*/,
                                             dealii::internal::int2type<1>)
     {
       // we may have to compute constraints for vertices. gotta think about
@@ -3153,7 +3153,7 @@ namespace DoFTools
     //   in the component_mask that corresponds to this shape function
     template <int dim, int spacedim>
     std::vector<unsigned char>
-    get_local_component_association (const FiniteElement<dim,spacedim>  &fe,
+    get_local_component_association (const FiniteElement<dim,spacedim> &fe,
                                      const ComponentMask        &component_mask)
     {
       std::vector<unsigned char> local_component_association (fe.dofs_per_cell,
@@ -4320,7 +4320,7 @@ namespace DoFTools
     void
     resolve_components (const FiniteElement<dim,spacedim> &fe,
                         const std::vector<unsigned char> &dofs_by_component,
-                        const std::vector<unsigned int>  &target_component,
+                        const std::vector<unsigned int> &target_component,
                         const bool                        only_once,
                         std::vector<unsigned int>        &dofs_per_component,
                         unsigned int                     &component)
@@ -4361,7 +4361,7 @@ namespace DoFTools
     void
     resolve_components (const hp::FECollection<dim,spacedim> &fe_collection,
                         const std::vector<unsigned char> &dofs_by_component,
-                        const std::vector<unsigned int>  &target_component,
+                        const std::vector<unsigned int> &target_component,
                         const bool                        only_once,
                         std::vector<unsigned int>        &dofs_per_component,
                         unsigned int                     &component)
@@ -4508,7 +4508,7 @@ namespace DoFTools
   void
   count_dofs_per_block (const DH &dof_handler,
                         std::vector<unsigned int> &dofs_per_block,
-                        const std::vector<unsigned int>  &target_block_)
+                        const std::vector<unsigned int> &target_block_)
   {
     std::vector<unsigned int>  target_block = target_block_;
 
@@ -5349,11 +5349,11 @@ namespace DoFTools
   {
     namespace
     {
-      template<class DH>
+      template <class DH>
       void
       map_dofs_to_support_points(const hp::MappingCollection<DH::dimension, DH::space_dimension> &mapping,
-                                 const DH  &dof_handler,
-                                 std::map<unsigned int,Point<DH::space_dimension> >  &support_points)
+                                 const DH &dof_handler,
+                                 std::map<unsigned int,Point<DH::space_dimension> > &support_points)
       {
         const unsigned int dim = DH::dimension;
         const unsigned int spacedim = DH::space_dimension;
@@ -5406,8 +5406,8 @@ namespace DoFTools
       template <class DH>
       void
       map_dofs_to_support_points(const hp::MappingCollection<DH::dimension, DH::space_dimension> &mapping,
-                                 const DH  &dof_handler,
-                                 std::vector<Point<DH::space_dimension> >  &support_points)
+                                 const DH &dof_handler,
+                                 std::vector<Point<DH::space_dimension> > &support_points)
       {
         // get the data in the form of the map as above
         std::map<unsigned int,Point<DH::space_dimension> >  x_support_points;
index a2a73a7776cf5ca710b98316227b6bc88f7ed797..9ec2a9708f3c247f97c766f2a403ac59bf3a7c9c 100644 (file)
@@ -25,7 +25,7 @@ DEAL_II_NAMESPACE_OPEN
 
 template <int dim, class EulerVectorType, int spacedim>
 MappingQ1Eulerian<dim, EulerVectorType, spacedim>::
-MappingQ1Eulerian (const EulerVectorType  &euler_transform_vectors,
+MappingQ1Eulerian (const EulerVectorType &euler_transform_vectors,
                    const DoFHandler<dim,spacedim> &shiftmap_dof_handler)
   :
   euler_transform_vectors(&euler_transform_vectors),
index 3e43ff6ce608b1c3503ecb1128934a7e7f083ca1..c66e4b02258be156104d50e1ecf4e8b3bec340b2 100644 (file)
@@ -232,7 +232,7 @@ namespace hp
 
   template <int dim, int spacedim>
   FEFaceValues<dim,spacedim>::FEFaceValues (const hp::MappingCollection<dim,spacedim> &mapping,
-                                            const hp::FECollection<dim,spacedim>  &fe_collection,
+                                            const hp::FECollection<dim,spacedim> &fe_collection,
                                             const hp::QCollection<dim-1> &q_collection,
                                             const UpdateFlags         update_flags)
     :
@@ -244,7 +244,7 @@ namespace hp
 
 
   template <int dim, int spacedim>
-  FEFaceValues<dim,spacedim>::FEFaceValues (const hp::FECollection<dim,spacedim>  &fe_collection,
+  FEFaceValues<dim,spacedim>::FEFaceValues (const hp::FECollection<dim,spacedim> &fe_collection,
                                             const hp::QCollection<dim-1> &q_collection,
                                             const UpdateFlags         update_flags)
     :
@@ -351,7 +351,7 @@ namespace hp
 
   template <int dim, int spacedim>
   FESubfaceValues<dim,spacedim>::FESubfaceValues (const hp::MappingCollection<dim,spacedim> &mapping,
-                                                  const hp::FECollection<dim,spacedim>  &fe_collection,
+                                                  const hp::FECollection<dim,spacedim> &fe_collection,
                                                   const hp::QCollection<dim-1> &q_collection,
                                                   const UpdateFlags         update_flags)
     :
@@ -363,7 +363,7 @@ namespace hp
 
 
   template <int dim, int spacedim>
-  FESubfaceValues<dim,spacedim>::FESubfaceValues (const hp::FECollection<dim,spacedim>  &fe_collection,
+  FESubfaceValues<dim,spacedim>::FESubfaceValues (const hp::FECollection<dim,spacedim> &fe_collection,
                                                   const hp::QCollection<dim-1> &q_collection,
                                                   const UpdateFlags         update_flags)
     :
index bc8b1321becd073d223471bb90e5263cfbbc412d..25b5f1ce566e1f26e4046d2459e5e358c701b7a3 100644 (file)
@@ -111,7 +111,7 @@ namespace TrilinosWrappers
 
 
 
-  SparseMatrix::SparseMatrix (const Epetra_Map  &input_map,
+  SparseMatrix::SparseMatrix (const Epetra_Map &input_map,
                               const unsigned int n_max_entries_per_row)
     :
     column_space_map (new Epetra_Map (input_map)),
@@ -137,8 +137,8 @@ namespace TrilinosWrappers
 
 
 
-  SparseMatrix::SparseMatrix (const Epetra_Map  &input_row_map,
-                              const Epetra_Map  &input_col_map,
+  SparseMatrix::SparseMatrix (const Epetra_Map &input_row_map,
+                              const Epetra_Map &input_col_map,
                               const unsigned int n_max_entries_per_row)
     :
     column_space_map (new Epetra_Map (input_col_map)),
@@ -353,7 +353,7 @@ namespace TrilinosWrappers
   template <typename SparsityType>
   void
   SparseMatrix::reinit (const Epetra_Map    &input_map,
-                        const SparsityType  &sparsity_pattern,
+                        const SparsityType &sparsity_pattern,
                         const bool           exchange_data)
   {
     reinit (input_map, input_map, sparsity_pattern, exchange_data);
@@ -365,7 +365,7 @@ namespace TrilinosWrappers
   void
   SparseMatrix::reinit (const Epetra_Map    &input_row_map,
                         const Epetra_Map    &input_col_map,
-                        const SparsityType  &sparsity_pattern,
+                        const SparsityType &sparsity_pattern,
                         const bool           exchange_data)
   {
     // release memory before reallocation

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.