]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Still fix Guido's bogus indentations.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 13 Apr 2000 15:16:16 +0000 (15:16 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 13 Apr 2000 15:16:16 +0000 (15:16 +0000)
git-svn-id: https://svn.dealii.org/trunk@2711 0785d39b-7218-0410-832d-ea1e28bc413d

16 files changed:
deal.II/deal.II/source/dofs/dof_constraints.cc
deal.II/deal.II/source/dofs/dof_handler.cc
deal.II/deal.II/source/dofs/dof_renumbering.cc
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/fe/fe.cc
deal.II/deal.II/source/fe/fe_lib.criss_cross.cc
deal.II/deal.II/source/fe/fe_lib.cubic.cc
deal.II/deal.II/source/fe/fe_lib.quadratic.cc
deal.II/deal.II/source/fe/fe_system.cc
deal.II/deal.II/source/fe/fe_values.cc
deal.II/deal.II/source/fe/q1_mapping.cc
deal.II/deal.II/source/numerics/data_io.cc
deal.II/deal.II/source/numerics/data_out_stack.cc
deal.II/deal.II/source/numerics/histogram.cc
deal.II/deal.II/source/numerics/solution_transfer.cc
deal.II/deal.II/source/numerics/vectors.cc

index 633e6b28903d4440816363d422f8f1657c196ddb..1df1b5b143927b4212b1a83ce20d8807562957e3 100644 (file)
@@ -162,7 +162,7 @@ void ConstraintMatrix::condense (const SparsityPattern &uncondensed,
          ExcMatrixNotSquare());
 
 
-// store for each line of the matrix
+                                  // store for each line of the matrix
                                   // its new line number
                                   // after compression. If the shift is
                                   // -1, this line will be condensed away
@@ -200,7 +200,7 @@ void ConstraintMatrix::condense (const SparsityPattern &uncondensed,
        new_line.push_back (row-shift);
 
 
-next_constraint = lines.begin();
+  next_constraint = lines.begin();
                                   // note: in this loop we need not check
                                   // whether #next_constraint# is a valid
                                   // iterator, since #next_constraint# is
index c8c875f41023b056075a359021e6551f3c0734bb..515d56b68799cb99fc0bea1968159907f8fd6bb2 100644 (file)
@@ -1315,13 +1315,13 @@ unsigned int DoFHandler<2>::distribute_dofs_on_cell (active_cell_iterator &cell,
       };
 
 
-// dofs of quad
+                                  // dofs of quad
   if (selected_fe->dofs_per_quad > 0)
     for (unsigned int d=0; d<selected_fe->dofs_per_quad; ++d)
       cell->set_dof_index (d, next_free_dof++);
 
 
-// note that this cell has been processed
+                                  // note that this cell has been processed
   cell->set_user_flag ();
   
   return next_free_dof;
@@ -1376,13 +1376,13 @@ unsigned int DoFHandler<3>::distribute_dofs_on_cell (active_cell_iterator &cell,
       };
 
 
-// dofs of hex
+                                  // dofs of hex
   if (selected_fe->dofs_per_hex > 0)
     for (unsigned int d=0; d<selected_fe->dofs_per_hex; ++d)
       cell->set_dof_index (d, next_free_dof++);
 
 
-// note that this cell has been processed
+                                  // note that this cell has been processed
   cell->set_user_flag ();
   
   return next_free_dof;
@@ -1656,7 +1656,7 @@ unsigned int DoFHandler<3>::max_couplings_between_dofs () const {
            27*selected_fe->dofs_per_hex);
 
 
-Assert (false, ExcNotImplemented());
+  Assert (false, ExcNotImplemented());
   return 0;
 };
 
index 2856331c4d1ca390d3c52cb26a2281737a8f50f7..999ed1d047916dc9fd95ffad0c1373f5a72a1849 100644 (file)
@@ -113,7 +113,7 @@ void DoFRenumbering::Cuthill_McKee (DoFHandler<dim>            &dof_handler,
     };
 
 
-// store next free dof index
+                                  // store next free dof index
   unsigned int next_free_number = 0;
 
                                   // enumerate the first round dofs
@@ -295,7 +295,7 @@ void DoFRenumbering::Cuthill_McKee (MGDoFHandler<dim>          &dof_handler,
     };
 
 
-// store next free dof index
+                                  // store next free dof index
   unsigned int next_free_number = 0;
 
                                   // enumerate the first round dofs
@@ -345,7 +345,7 @@ void DoFRenumbering::Cuthill_McKee (MGDoFHandler<dim>          &dof_handler,
        continue;
 
 
-// store for each coordination
+                                      // store for each coordination
                                       // number the dofs with these
                                       // coordination number
       multimap<unsigned int, int> dofs_by_coordination;
index 27d6282af772ce8dba5c5f6c1782414c5c196abf..e7a841a06d3493a8b53e697112e75a22af3170e5 100644 (file)
@@ -87,7 +87,7 @@ DoFTools::make_sparsity_pattern (const DoFHandler<dim>       &dof,
                       [dof.get_fe().system_to_component_index(j).first];
 
 
-vector<unsigned int> dofs_on_this_cell(dofs_per_cell);
+  vector<unsigned int> dofs_on_this_cell(dofs_per_cell);
   DoFHandler<dim>::active_cell_iterator cell = dof.begin_active(),
                       endc = dof.end();
   for (; cell!=endc; ++cell) 
@@ -358,7 +358,7 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<2> &dof_handler,
        cell->face(face)->set_user_flag();
 
 
-// loop over all lines; only on lines
+                                  // loop over all lines; only on lines
                                   // there can be constraints.
   for (line = dof_handler.begin_line(); line != endl; ++line)
                                     // if dofs on this line are subject
@@ -449,7 +449,7 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<3> &dof_handler,
        cell->face(face)->set_user_flag();
 
 
-// loop over all faces; only on faces
+                                  // loop over all faces; only on faces
                                   // there can be constraints.
   for (face=dof_handler.begin_face(); face != endf; ++face)
                                     // if dofs on this line are subject
index ccdd4e4ffc5973011e60f9262c5f063391380f4c..bc0a1c0168a654b6a5d3826e8400835622cdbc61 100644 (file)
@@ -285,7 +285,7 @@ void FiniteElement<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
          ExcWrongFieldDimension(support_points.size(), dofs_per_cell));
 
 
-// local mesh width
+                                  // local mesh width
   const double h=(cell->vertex(1)(0) - cell->vertex(0)(0));
 
   for (unsigned int i=0; i<q_points.size(); ++i) 
@@ -313,6 +313,7 @@ void FiniteElement<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
 };
 
 
+
 template <>
 void FiniteElement<1>::fill_fe_face_values (const DoFHandler<1>::cell_iterator &,
                                            const unsigned int       ,
index b16cb3bfc988557848727992bcbf3a6e228156c4..2819712774610b6a632ecdc3e64b34556cf02242 100644 (file)
   od:
 
 
-# these are the basis functions differentiated with respect to
+  # these are the basis functions differentiated with respect to
   # xi and eta. we need them for the computation of the jacobi
   # matrix, since we can't just differentiate a function.
   phi_xi[0] := proc(x,y) if(y<1-x) then -1;  else 0; fi; end:
           end:
 
 
-# Now for the mass matrix: we divide the entire cell into four
+  # Now for the mass matrix: we divide the entire cell into four
   # sectors:
   #
   # *-------*
@@ -917,7 +917,7 @@ void FECrissCross<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &ce
          ExcWrongFieldDimension(support_points.size(), dofs_per_cell));
 
 
-unsigned int n_points=unit_points.size();
+  unsigned int n_points=unit_points.size();
 
                                   // we need the support points in any
                                   // way, wanted or not by the user
@@ -1027,7 +1027,7 @@ unsigned int n_points=unit_points.size();
       };
 
 
-if (compute_jacobians_grad)
+  if (compute_jacobians_grad)
     switch (dim) 
       {
        case 1:
index f57b895910e7c99f72a5fbaca98073846fcd6b7d..eaef602191f492d70b811e0f2b18a89e5940a4a7 100644 (file)
@@ -9868,7 +9868,7 @@ void FEQ3<3>::initialize_matrices ()
       prolongation[7](63,62) = 225.0/256.0;
 
 
-restriction[0](0,0) = 1.0;
+      restriction[0](0,0) = 1.0;
       restriction[0](8,9) = 1.0;
       restriction[0](14,15) = 1.0;
       restriction[0](24,25) = 1.0;
index 7d97394c37c368676b23300829107c293085674e..2588b9699437c87b2409f19dac74dfed83502a6f 100644 (file)
@@ -65,7 +65,7 @@ void FEQ2<1>::initialize_matrices () {
   od;
 
 
-# to get the restriction (interpolation) matrices, evaluate
+  # to get the restriction (interpolation) matrices, evaluate
   # the basis functions on the child cells at the global
   # interpolation points
 
index 2bac4eaa732f151faa58bd883c0f76960fa014c1..7ea6db0b1560278bd0be63347e34d88ba1641c19 100644 (file)
@@ -489,7 +489,7 @@ void FESystem<dim>::initialize ()
          };
 
 
-// now set up the interface constraints.
+                                  // now set up the interface constraints.
                                   // this is kind'o hairy, so don't try
                                   // to do it dimension independent
   build_interface_constraints ();
@@ -755,7 +755,7 @@ FESystem<dim>::shape_grad_grad (const unsigned int  i,
   Assert((i<dofs_per_cell), ExcIndexRange(i, 0, dofs_per_cell));
 
 
-pair<unsigned,unsigned> comp = system_to_component_index(i);
+  pair<unsigned,unsigned> comp = system_to_component_index(i);
   
   return base_element(component_to_base_table[comp.first])
     .shape_grad_grad(comp.second, p);
index 8bd23bd5fb405fa984a57c92641bc84814f01e9e..b0ff1455be2e9c702cd7817f4105a849c75a71b1 100644 (file)
@@ -398,7 +398,7 @@ void FEValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell)
          contract (tmp2, tmp1, 1, jacobi_matrices[j], 1);
 
 
-// second part:
+                                          // second part:
                                           // tmp1 := (d_k J_lj) (d_l phi)
          contract (tmp1, jacobi_matrices_grad[j], 2, unit_shape_gradients[i][j]);
                                           // tmp1_kj J_ki
@@ -411,7 +411,7 @@ void FEValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &cell)
        };
 
 
-// compute Jacobi determinants in
+                                  // compute Jacobi determinants in
                                   // quadrature points.
                                   // refer to the general doc for
                                   // why we take the inverse of the
@@ -577,7 +577,7 @@ void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &c
       };
 
 
-Tensor<2,dim> tmp1, tmp2;
+  Tensor<2,dim> tmp1, tmp2;
   if (update_flags & update_second_derivatives)
     for (unsigned int i=0; i<fe->dofs_per_cell; ++i)
       for (unsigned int j=0; j<n_quadrature_points; ++j)
@@ -588,7 +588,7 @@ Tensor<2,dim> tmp1, tmp2;
          contract (tmp2, tmp1, 1, jacobi_matrices[j], 1);
 
 
-// second part:
+                                          // second part:
                                           // tmp1 := (d_k J_lj) (d_l phi)
          contract (tmp1,
                    jacobi_matrices_grad[j], 2,
@@ -603,7 +603,7 @@ Tensor<2,dim> tmp1, tmp2;
        };
 
 
-// compute Jacobi determinants in
+                                  // compute Jacobi determinants in
                                   // quadrature points.
                                   // refer to the general doc for
                                   // why we take the inverse of the
@@ -758,7 +758,7 @@ void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator
          contract (tmp2, tmp1, 1, jacobi_matrices[j], 1);
 
 
-// second part:
+                                          // second part:
                                           // tmp1 := (d_k J_lj) (d_l phi)
          contract (tmp1,
                    jacobi_matrices_grad[j], 2,
@@ -773,7 +773,7 @@ void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator
        };
 
 
-// compute Jacobi determinants in
+                                  // compute Jacobi determinants in
                                   // quadrature points.
                                   // refer to the general doc for
                                   // why we take the inverse of the
index 0218d03fe1653aa4f35214c53d683f5ed6c532f3..5b492d277e8f58cd9051550de9feb6a6a72b439f 100644 (file)
@@ -561,14 +561,14 @@ void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cel
          ExcWrongFieldDimension(support_points.size(), dofs_per_cell));
 
 
-unsigned int n_points=unit_points.size();
+  unsigned int n_points=unit_points.size();
 
   Point<dim> vertices[GeometryInfo<dim>::vertices_per_cell];
   for (unsigned int l=0; l<GeometryInfo<dim>::vertices_per_cell; ++l)
     vertices[l] = cell->vertex(l);
 
 
-if (compute_q_points) 
+  if (compute_q_points) 
     {
                                       // initialize points to zero
       for (unsigned int i=0; i<n_points; ++i)
@@ -636,7 +636,7 @@ if (compute_q_points)
     };
 
 
-One last note regarding whether we have to invert M or M transposed: it is
+  One last note regarding whether we have to invert M or M transposed: it is
   easy to try out, by computing the gradients of a function on a distorted
   cell (just move one vertex) where the nodal values for linear elements
   are one for the moved vertex and zero otherwise. Please also note that
@@ -673,7 +673,7 @@ One last note regarding whether we have to invert M or M transposed: it is
     fevalues.reinit (dof.begin_active(),b);
 
 
-Vector<double> val(4);
+    Vector<double> val(4);
     val(2) = 1;
 
     vector<Point<2> > grads(4);
index 1c070ed2e74dbe0415fd1633e04fb885ab1b3968..551c7f529228dc4ea5746d4e7856077fd13e8a7e 100644 (file)
@@ -121,7 +121,7 @@ void DataOut_Old<dim>::write_ucd (ostream &out) const {
     };
 
 
-// write preamble
+                                  // write preamble
   if (true)
     {
 /*      
@@ -432,7 +432,7 @@ void DataOut_Old<dim>::write_gnuplot (ostream &out, unsigned int accuracy) const
     };
 
 
-DoFHandler<dim>::active_cell_iterator cell;
+  DoFHandler<dim>::active_cell_iterator cell;
   DoFHandler<dim>::active_cell_iterator endc = dofs->end();
 
   QTrapez<1>     q_trapez;
@@ -543,7 +543,7 @@ DoFHandler<dim>::active_cell_iterator cell;
                  };
 
 
-break;
+               break;
 
          default:
                Assert (false, ExcNotImplemented());
@@ -610,7 +610,7 @@ void DataOut_Old<dim>::write_gnuplot_draft (ostream &out) const
     };
 
 
-DoFHandler<dim>::active_cell_iterator cell;
+  DoFHandler<dim>::active_cell_iterator cell;
   DoFHandler<dim>::active_cell_iterator endc = dofs->end();
 
   unsigned int cell_index=0;
@@ -748,7 +748,7 @@ DoFHandler<dim>::active_cell_iterator cell;
                out << endl << endl;
 
 
-break;
+               break;
                
          default:
                Assert (false, ExcNotImplemented());
@@ -815,7 +815,7 @@ void DataOut_Old<2>::write_povray_mesh (ostream &out) const {
       << endl;
 
 
-// write frame object
+                                  // write frame object
   out << "mesh {" << endl;
   
   DoFHandler<2>::active_cell_iterator cell;
@@ -902,7 +902,7 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
   };  
 
 
-// Make output values local by
+                                   // Make output values local by
                                    // copying them to a multiset.
                                    // Perform the necessary turn.
    const DoFHandler<2>::active_cell_iterator endc = dofs->end();
@@ -1008,7 +1008,7 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
    cells2.clear();
 
 
-// If we want shaded output we can
+                                   // If we want shaded output we can
                                    // do the shading now.
    if (cell_shade_p)
      {
@@ -1016,7 +1016,8 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
        double light_norm, normal_norm;
        float color;
 
-       for (multiset<DataOut_Old<2>::EpsCellData>::iterator c=cells.begin();c!=cells.end();++c)
+       for (multiset<DataOut_Old<2>::EpsCellData>::iterator c=cells.begin();
+           c!=cells.end(); ++c)
         {
           EpsCellData cd(*c);
 
@@ -1061,7 +1062,7 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
      cells2.swap (cells);
 
 
-// Next we have to shift and scale
+                                   // Next we have to shift and scale
                                    // a bit so that everything still
                                    // arrives in our bounding box of
                                    // 310x310.
@@ -1088,7 +1089,7 @@ void DataOut_Old<2>::write_eps (ostream &out, const EpsOutputData &eod) const {
      };
 
 
-//  Now we are ready to output...
+                                   //  Now we are ready to output...
    for (multiset<DataOut_Old<2>::EpsCellData>::iterator c=cells.begin();
        c!=cells.end(); ++c)
      {
@@ -1158,7 +1159,7 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
       << endl;
 
 
-///////////////////////////////
+                                  ///////////////////////////////
                                   // first make up a list of used
                                   // vertices along with their
                                   // coordinates. since dofs have
@@ -1250,7 +1251,7 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
     };
 
 
-/////////////////////////////////////
+                                  /////////////////////////////////////
                                   // now for the cells. this is simpler
                                   // than the above task
   if (true)
@@ -1275,7 +1276,7 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
     };
 
 
-///////////////////////////////////////
+                                  ///////////////////////////////////////
                                   // data output.
   out << "variable" << endl;
 
@@ -1333,7 +1334,7 @@ void DataOut_Old<dim>::write_gmv (ostream &out) const
     };
 
 
-// Cell data is the simplest since the order
+                                  // Cell data is the simplest since the order
                                   // already is correct
   if (true)
     {
index c26d11dc1347e5187337bc95f3c1832347e5d42d..747d359aab7eaa0827e8f0d6c9df14378af0c908 100644 (file)
@@ -189,7 +189,7 @@ void DataOutStack<dim>::build_patches (const unsigned int n_subdivisions)
     ++n_patches;
 
 
-// before we start the loop:
+                                  // before we start the loop:
                                   // create a quadrature rule that
                                   // actually has the points on this
                                   // patch, and an object that
@@ -239,7 +239,7 @@ void DataOutStack<dim>::build_patches (const unsigned int n_subdivisions)
        };
 
 
-// now fill in the the data values.
+                                      // now fill in the the data values.
                                       // note that the required order is
                                       // with highest coordinate running
                                       // fastest, we need to enter each
index 47a1c9ed6659b25a6ed8739b8e2c2ecf3becdca4..eac882012daf4027c0a2291fc8fa547838dae680 100644 (file)
@@ -96,7 +96,7 @@ void Histogram::evaluate (const vector<Vector<number> > &values,
            );
 
 
-for (unsigned int i=1; i<values.size(); ++i)
+           for (unsigned int i=1; i<values.size(); ++i)
              {
                min_value = min (min_value,
                                 *min_element(values[i].begin(),
@@ -148,7 +148,7 @@ for (unsigned int i=1; i<values.size(); ++i)
     max_value = min_value+1;
 
 
-// now set up the intervals based on
+                                  // now set up the intervals based on
                                   // the min and max values
   intervals.clear ();
                                   // set up one list of intervals
@@ -191,7 +191,7 @@ for (unsigned int i=1; i<values.size(); ++i)
     intervals.push_back (intervals[0]);
 
 
-// finally fill the intervals
+                                  // finally fill the intervals
   for (unsigned int i=0; i<values.size(); ++i)
     for (Vector<number>::const_iterator p=values[i].begin();
         p < values[i].end(); ++p)
index 9c8555308cf93a7cf831bc6aa809f30759287495..6602941f16da8148adcc72ad4d17733ddcfc3c63 100644 (file)
@@ -202,7 +202,7 @@ prepare_for_coarsening_and_refinement(const vector<Vector<number> > &all_in)
                                              n_coarsen_fathers);
 
 
-// we need counters for
+                                  // we need counters for
                                   // the 'to_stay_or_refine' cells 'n_sr',
                                   // the 'coarsen_fathers' cells 'n_cf',
                                   // and all the cells where a
@@ -292,7 +292,7 @@ interpolate (const vector<Vector<number> > &all_in,
     };
 
 
-const unsigned int dofs_per_cell=dof_handler->get_fe().dofs_per_cell;  
+  const unsigned int dofs_per_cell=dof_handler->get_fe().dofs_per_cell;  
   Vector<number> local_values(dofs_per_cell);
 
   vector<unsigned int>    *indexptr;
index fbc735a53da74d2af1af710213b879536f4ed90c..e988a14fbf612f22baa08d325986273efc4645c9 100644 (file)
@@ -956,7 +956,7 @@ VectorTools::integrate_difference (const DoFHandler<dim>    &dof,
        };
 
 
-// append result of this cell
+                                      // append result of this cell
                                       // to the end of the vector
       difference(index) = diff;
     };

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.