]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Still remove many of those bogus indentations!
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 30 Mar 2000 13:40:36 +0000 (13:40 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 30 Mar 2000 13:40:36 +0000 (13:40 +0000)
git-svn-id: https://svn.dealii.org/trunk@2650 0785d39b-7218-0410-832d-ea1e28bc413d

14 files changed:
deal.II/deal.II/include/dofs/dof_handler.h
deal.II/deal.II/include/fe/fe.h
deal.II/deal.II/include/fe/fe_system.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/fe/q1_mapping.h
deal.II/deal.II/include/grid/grid_out.h
deal.II/deal.II/include/grid/tria.h
deal.II/deal.II/include/grid/tria_levels.h
deal.II/deal.II/include/numerics/data_out_stack.h
deal.II/deal.II/include/numerics/dof_renumbering.h
deal.II/deal.II/include/numerics/histogram.h
deal.II/deal.II/include/numerics/time_dependent.h
deal.II/deal.II/include/numerics/vectors.h
deal.II/lac/include/lac/vector.h

index 67cc4a3b178ddee0ef2ded0f42d6706a7fb11686..16313096340b11d0f5df8f00282ceaee519d9ccb 100644 (file)
@@ -720,7 +720,7 @@ class DoFHandler  :  public Subscriptor,
                                     //@}
 
 
-/*---------------------------------------*/
+                                    /*---------------------------------------*/
 
                                     /**
                                      *  @name Line iterator functions
@@ -779,7 +779,7 @@ class DoFHandler  :  public Subscriptor,
     active_line_iterator end_active_line (const unsigned int level) const;
 
 
-/**
+                                    /**
                                      *  Return an iterator pointing to the
                                      *  last line, used or not.
                                      */
@@ -876,7 +876,7 @@ class DoFHandler  :  public Subscriptor,
     active_quad_iterator end_active_quad (const unsigned int level) const;
 
 
-/**
+                                    /**
                                      *  Return an iterator pointing to the
                                      *  last quad, used or not.
                                      */
@@ -1023,7 +1023,7 @@ class DoFHandler  :  public Subscriptor,
                                     /*---------------------------------------*/
 
 
-/**
+                                    /**
                                      * Return number of degrees of freedom.
                                      * Included in this number are those
                                      * DoFs which are constrained by
index 81dbc4c91f1fdf62b1b2224f72f701b8eccc0a5d..da23ce0be463fb4d3eeb7658489671dbc0111329 100644 (file)
@@ -106,7 +106,7 @@ class FiniteElementData
     const unsigned int transform_functions;
 
 
-/**
+                                    /**
                                      * Number of components and dimension of
                                      * the image space.
                                      */
@@ -199,7 +199,7 @@ class FiniteElementData
     unsigned int n_transform_functions () const;
 
 
-/**
+                                    /**
                                      * Comparison operator. It is not clear to
                                      * me (WB) why we have to declare and implement
                                      * this one explicitely.
index b1089cd5dad509c49597bc210e9a26b30308b403..eb792f8c50b9b51965a06b869305e6324c3acfb1 100644 (file)
@@ -345,7 +345,9 @@ class FESystem : public FiniteElement<dim>
                                     vector<Point<dim> >         &normal_vectors) const;
 
                                     /**
-                                     * Implementation of the corresponding function of #FiniteElement#.
+                                     * Implementation of the
+                                     * corresponding function of
+                                     * #FiniteElement#.
                                      */
     virtual void fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
                                 const vector<Point<dim> >            &unit_points,
@@ -399,7 +401,8 @@ class FESystem : public FiniteElement<dim>
   private:
 
                                     /**
-                                     * Pairs of multiplicity and element type.
+                                     * Pairs of multiplicity and
+                                     * element type.
                                      */
     typedef pair<const FiniteElement<dim> *, unsigned int> ElementPair;
     
@@ -417,7 +420,7 @@ class FESystem : public FiniteElement<dim>
     vector< ElementPair > base_elements;
 
 
-/**
+                                    /**
                                      * Helper function used in the constructor:
                                      * take a #FiniteElementData# object
                                      * and return an object of the same type
@@ -455,7 +458,7 @@ class FESystem : public FiniteElement<dim>
                          const unsigned int            N3);
 
 
-/**
+                                    /**
                                      * Helper function used in the constructor:
                                      * takes a #FiniteElement# object
                                      * and returns an boolean vector including
@@ -466,6 +469,7 @@ class FESystem : public FiniteElement<dim>
     static vector<bool>
     compute_restriction_is_additive_flags (const FiniteElement<dim> &fe,
                                           const unsigned int        N);
+    
                                     /**
                                      * Same as above for mixed elements
                                      * with two different sub-elements.
index be937cadba54d16ad83adcaeb8fbc2b34f065306..736522b5bd9d85c806ba6ecebe073d7b1796e341 100644 (file)
@@ -259,7 +259,7 @@ class FEValuesBase
                  const FiniteElement<dim> &fe);
 
 
-/**
+                                    /**
                                      * Return the value of the #i#th shape
                                      * function at the #j# quadrature point
                                      * on the cell, face or subface selected
@@ -738,7 +738,7 @@ class FEValues : public FEValuesBase<dim>
   public:
 
 
-/**
+                                    /**
                                      * Constructor. Fill all arrays with the
                                      * values of the shape functions of the
                                      * specified finite element using the
@@ -883,7 +883,7 @@ class FEValues : public FEValuesBase<dim>
  *  available without complicated matrix-vector-multiplications.
  *    
  *  @author Wolfgang Bangerth, 1998
-*/
+ */
 template <int dim>
 class FEFaceValuesBase : public FEValuesBase<dim>
 {
index e5a20522a06c7124979ab191cf943465745dd050..298edb09b4f8d5b034704b22366766e9ae192e24 100644 (file)
@@ -177,7 +177,7 @@ class FEQ1Mapping : public FiniteElement<dim>
                                            vector<Tensor<3,dim> >               &jacobians);
 
 
-/**
+                                    /**
                                      * Exception
                                      */
     DeclException0 (ExcInternalError);
index a64027718c864d0e7a818ee1596b08c1bae7ba1d..40986ceba097f57c1d4826ed3f5d034eae41e9d8 100644 (file)
@@ -213,7 +213,7 @@ class GridOut
     };
 
 
-/**
+                                    /**
                                      * Flags describing the details of
                                      * output in GNUPLOT format.
                                      */
@@ -313,7 +313,7 @@ class GridOut
     };
 
 
-/**
+                                    /**
                                      * Flags describing the details of
                                      * output for encapsulated postscript
                                      * for all dimensions not explicitely
@@ -371,7 +371,7 @@ class GridOut
 //#endif
 
 
-/**
+                                    /**
                                      * Declaration of a name for each of the
                                      * different output formats.
                                      */
@@ -498,7 +498,7 @@ class GridOut
     static string get_output_format_names ();
 
 
-/**
+                                    /**
                                      * Exception
                                      */
     DeclException0 (ExcInvalidState);
@@ -548,7 +548,7 @@ class GridOut
     EpsFlags<3>  eps_flags_3;
 
 
-/**
+                                    /**
                                      * Write the grid information about
                                      * faces to #out#. Only those faces
                                      * are printed which are on the boundary
index 7076cc876536e532ccd095c7cd20e6fee185e41b..90e769c8e47b9526d7ddf51be467029999239884 100644 (file)
@@ -1781,7 +1781,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
                         const bool   keep_boundary=true);
 
 
-/**
+                                    /**
                                      *  @name Mesh refinement
                                      */
                                     /*@{*/
@@ -2042,7 +2042,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                     /*@}*/
 
 
-/**
+                                    /**
                                      *  @name User flag handling
                                      */
                                     /*@{*/
@@ -2226,7 +2226,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
     active_cell_iterator end_active (const unsigned int level) const;
 
 
-/**
+                                    /**
                                      *  Return an iterator pointing to the
                                      *  last cell, used or not.
                                      *
@@ -2408,7 +2408,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                     /*@}*/
 
 
-/*---------------------------------------*/
+                                    /*---------------------------------------*/
 
                                     /**
                                      *  @name Line iterator functions
@@ -2888,7 +2888,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
                                     /*@}*/
 
 
-/**
+                                    /**
                                      *  @name Exceptions
                                      */
                                     /*@{*/
@@ -3115,7 +3115,7 @@ class Triangulation : public TriaDimensionInfo<dim>,
     void update_number_cache_hexes ();
 
 
-/**
+                                    /**
                                      *  Array of pointers pointing to the
                                      *  #TriangulationLevel<dim># objects
                                      *  storing the data on the different
index b7444a186c98e723e494d1fd356a2b9f66d0e0a2..9f0897749a1961915521671f4530bc3dca1a4e2b 100644 (file)
@@ -393,7 +393,7 @@ class TriangulationLevel<2> :  public TriangulationLevel<1>
        vector<unsigned char> material_id;
 
 
-/**
+                                        /**
                                          * Pointer which is not used by the
                                          * library but may be accessed an set
                                          * by the user to handle data local to
@@ -499,7 +499,7 @@ class TriangulationLevel<3> :  public TriangulationLevel<2>
        vector<unsigned char> material_id;
 
 
-/**
+                                        /**
                                          * Pointer which is not used by the
                                          * library but may be accessed an set
                                          * by the user to handle data local to
index af0bfbb5c56e94d44f6d894b77938667c32ec335..0289205e753f965a20d4362902e06d83966944c6 100644 (file)
@@ -178,7 +178,7 @@ class DataOutStack : public DataOutInterface<dim+1>
                              const VectorType      vector_type);
 
 
-/**
+                                    /**
                                      * Add a data vector for the presently
                                      * set value of the parameter.
                                      *
@@ -391,7 +391,7 @@ class DataOutStack : public DataOutInterface<dim+1>
     virtual const vector<DataOutBase::Patch<dim+1> > & get_patches () const;
 
 
-/**
+                                    /**
                                      * Virtual function through
                                      * which the names of data sets are
                                      * obtained by the output functions
index af0809ae9579e9a2e9fcb8ce133c732ee0ccf036..6cfc7806635cda8e4aaf24130459889be5ec03ee 100644 (file)
@@ -246,7 +246,7 @@ class DoFRenumbering
                                const vector<unsigned int> &component_order = vector<unsigned int>());
 
 
-/**
+                                    /**
                                      * Exception
                                      */
     DeclException0 (ExcRenumberingIncomplete);
index e0c78a5dff85913c23a7d5633094fc8268650af1..922c04b59fc3511922cc9f8ff9c49f5bf823c37d 100644 (file)
@@ -72,7 +72,7 @@ class Histogram
     };
 
 
-/**
+                                    /**
                                      * Take several lists of values, each on
                                      * to produce one histogram that will
                                      * then be arrange one behind each other.
index 25a4f393340ffbba01dbe05eec8786ce86bfba2b..764edcfdf8f8f87584884560363f5d8f101b1770 100644 (file)
@@ -434,7 +434,7 @@ class TimeDependent
                   const TimeSteppingData &data_postprocess);
 
 
-/**
+                                    /**
                                      * Destructor. This will delete the
                                      * objects pointed to by the pointers
                                      * given to the #insert_*# and
@@ -604,7 +604,7 @@ class TimeDependent
                  const Direction         direction);
 
 
-/**
+                                    /**
                                      * Initialize the objects for the next
                                      * sweep. This function specifically does
                                      * the following: assign each time
@@ -1075,7 +1075,7 @@ class TimeStepBase : public Subscriptor
     void set_sweep_no (const unsigned int sweep_no);
 
 
-/**
+                                    /**
                                      * Copy constructor. I can see no reason
                                      * why someone might want to use it, so
                                      * I don't provide it. Since this class
@@ -1138,7 +1138,7 @@ class TimeStepBase_Tria :  public TimeStepBase
     };
 
 
-/**
+                                    /**
                                      * Default constructor. Does nothing but
                                      * throws an exception. We need to have
                                      * such a constructor in order to satisfy
@@ -1633,7 +1633,7 @@ struct TimeStepBase_Tria<dim>::RefinementFlags
     const unsigned int  first_sweep_with_correction;
 
 
-/**
+                                    /**
                                      * Apply cell number correction with the
                                      * previous time level only if there are
                                      * more than this number of cells.
@@ -1788,7 +1788,7 @@ void TimeDependent::do_loop (InitFunctionObject      init_function,
       };
 
 
-// wake up the first few time levels
+                                  // wake up the first few time levels
   for (int step=-timestepping_data.look_ahead; step<0; ++step)
     for (int look_ahead=0;
         look_ahead<=static_cast<int>(timestepping_data.look_ahead); ++look_ahead)
@@ -1805,7 +1805,7 @@ void TimeDependent::do_loop (InitFunctionObject      init_function,
        };
 
 
-for (unsigned int step=0; step<n_timesteps; ++step)
+  for (unsigned int step=0; step<n_timesteps; ++step)
     {
                                       // first thing: wake up the
                                       // timesteps ahead as necessary
@@ -1824,7 +1824,7 @@ for (unsigned int step=0; step<n_timesteps; ++step)
          };
 
 
-// actually do the work
+                                      // actually do the work
       switch (direction)
        {
          case forward:
index 762234c0db456e141ed1511b66654bcaecbcd6c4..3b2e82bffd622fadcb77d5e5ba0431b577b70b0f 100644 (file)
@@ -511,7 +511,7 @@ class VectorTools
                                    const vector<bool> &p_select);
 
 
-/**
+                                    /**
                                      * Exception
                                      */
     DeclException0 (ExcNotUseful);
index b5017424a15b6659c02eb62c83f5401a9bff1a0e..6e39eaa79dc042c4a7a4efd8b63e37e56f511b37 100644 (file)
@@ -49,7 +49,7 @@ class Vector {
     typedef size_t size_type;
 
 
-/**
+                                    /**
                                      * @name 1: Basic Object-handling 
                                      */
                                     //@{
@@ -159,7 +159,7 @@ class Vector {
     Number linfty_norm () const;
 
 
-/**
+                                    /**
                                      * Change the dimension of the vector to
                                      * #N#. The reserved memory for this vector
                                      * remains unchanged if possible, to make
@@ -239,7 +239,7 @@ class Vector {
                                     //@}
 
 
-/**
+                                    /**
                                      * @name 2: Data-Access
                                      */
                                     //@{
@@ -256,7 +256,7 @@ class Vector {
                                     //@}
 
 
-/**
+                                    /**
                                      * @name 3: Modification of vectors
                                      */
                                     //@{
@@ -364,7 +364,7 @@ class Vector {
                                     //@}
 
 
-/**
+                                    /**
                                      * @name 5: Mixed stuff
                                      */
                                     //@{

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.