From: Wolfgang Bangerth Date: Thu, 13 Apr 2000 15:16:16 +0000 (+0000) Subject: Still fix Guido's bogus indentations. X-Git-Tag: v8.0.0~20681 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=052f08b3e868629641508dc767cd67a8b5c78208;p=dealii.git Still fix Guido's bogus indentations. git-svn-id: https://svn.dealii.org/trunk@2711 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/source/dofs/dof_constraints.cc b/deal.II/deal.II/source/dofs/dof_constraints.cc index 633e6b2890..1df1b5b143 100644 --- a/deal.II/deal.II/source/dofs/dof_constraints.cc +++ b/deal.II/deal.II/source/dofs/dof_constraints.cc @@ -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 diff --git a/deal.II/deal.II/source/dofs/dof_handler.cc b/deal.II/deal.II/source/dofs/dof_handler.cc index c8c875f410..515d56b687 100644 --- a/deal.II/deal.II/source/dofs/dof_handler.cc +++ b/deal.II/deal.II/source/dofs/dof_handler.cc @@ -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; ddofs_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; ddofs_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; }; diff --git a/deal.II/deal.II/source/dofs/dof_renumbering.cc b/deal.II/deal.II/source/dofs/dof_renumbering.cc index 2856331c4d..999ed1d047 100644 --- a/deal.II/deal.II/source/dofs/dof_renumbering.cc +++ b/deal.II/deal.II/source/dofs/dof_renumbering.cc @@ -113,7 +113,7 @@ void DoFRenumbering::Cuthill_McKee (DoFHandler &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 &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 &dof_handler, continue; -// store for each coordination + // store for each coordination // number the dofs with these // coordination number multimap dofs_by_coordination; diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index 27d6282af7..e7a841a06d 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -87,7 +87,7 @@ DoFTools::make_sparsity_pattern (const DoFHandler &dof, [dof.get_fe().system_to_component_index(j).first]; -vector dofs_on_this_cell(dofs_per_cell); + vector dofs_on_this_cell(dofs_per_cell); DoFHandler::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 diff --git a/deal.II/deal.II/source/fe/fe.cc b/deal.II/deal.II/source/fe/fe.cc index ccdd4e4ffc..bc0a1c0168 100644 --- a/deal.II/deal.II/source/fe/fe.cc +++ b/deal.II/deal.II/source/fe/fe.cc @@ -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::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 , diff --git a/deal.II/deal.II/source/fe/fe_lib.criss_cross.cc b/deal.II/deal.II/source/fe/fe_lib.criss_cross.cc index b16cb3bfc9..2819712774 100644 --- a/deal.II/deal.II/source/fe/fe_lib.criss_cross.cc +++ b/deal.II/deal.II/source/fe/fe_lib.criss_cross.cc @@ -116,7 +116,7 @@ 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: @@ -168,7 +168,7 @@ 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::fill_fe_values (const DoFHandler::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: diff --git a/deal.II/deal.II/source/fe/fe_lib.cubic.cc b/deal.II/deal.II/source/fe/fe_lib.cubic.cc index f57b895910..eaef602191 100644 --- a/deal.II/deal.II/source/fe/fe_lib.cubic.cc +++ b/deal.II/deal.II/source/fe/fe_lib.cubic.cc @@ -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; diff --git a/deal.II/deal.II/source/fe/fe_lib.quadratic.cc b/deal.II/deal.II/source/fe/fe_lib.quadratic.cc index 7d97394c37..2588b96994 100644 --- a/deal.II/deal.II/source/fe/fe_lib.quadratic.cc +++ b/deal.II/deal.II/source/fe/fe_lib.quadratic.cc @@ -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 diff --git a/deal.II/deal.II/source/fe/fe_system.cc b/deal.II/deal.II/source/fe/fe_system.cc index 2bac4eaa73..7ea6db0b15 100644 --- a/deal.II/deal.II/source/fe/fe_system.cc +++ b/deal.II/deal.II/source/fe/fe_system.cc @@ -489,7 +489,7 @@ void FESystem::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::shape_grad_grad (const unsigned int i, Assert((i comp = system_to_component_index(i); + pair comp = system_to_component_index(i); return base_element(component_to_base_table[comp.first]) .shape_grad_grad(comp.second, p); diff --git a/deal.II/deal.II/source/fe/fe_values.cc b/deal.II/deal.II/source/fe/fe_values.cc index 8bd23bd5fb..b0ff1455be 100644 --- a/deal.II/deal.II/source/fe/fe_values.cc +++ b/deal.II/deal.II/source/fe/fe_values.cc @@ -398,7 +398,7 @@ void FEValues::reinit (const typename DoFHandler::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::reinit (const typename DoFHandler::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::reinit (const typename DoFHandler::cell_iterator &c }; -Tensor<2,dim> tmp1, tmp2; + Tensor<2,dim> tmp1, tmp2; if (update_flags & update_second_derivatives) for (unsigned int i=0; idofs_per_cell; ++i) for (unsigned int j=0; j 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::reinit (const typename DoFHandler::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::reinit (const typename DoFHandler::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 diff --git a/deal.II/deal.II/source/fe/q1_mapping.cc b/deal.II/deal.II/source/fe/q1_mapping.cc index 0218d03fe1..5b492d277e 100644 --- a/deal.II/deal.II/source/fe/q1_mapping.cc +++ b/deal.II/deal.II/source/fe/q1_mapping.cc @@ -561,14 +561,14 @@ void FEQ1Mapping::fill_fe_values (const DoFHandler::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 vertices[GeometryInfo::vertices_per_cell]; for (unsigned int l=0; l::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 val(4); + Vector val(4); val(2) = 1; vector > grads(4); diff --git a/deal.II/deal.II/source/numerics/data_io.cc b/deal.II/deal.II/source/numerics/data_io.cc index 1c070ed2e7..551c7f5292 100644 --- a/deal.II/deal.II/source/numerics/data_io.cc +++ b/deal.II/deal.II/source/numerics/data_io.cc @@ -121,7 +121,7 @@ void DataOut_Old::write_ucd (ostream &out) const { }; -// write preamble + // write preamble if (true) { /* @@ -432,7 +432,7 @@ void DataOut_Old::write_gnuplot (ostream &out, unsigned int accuracy) const }; -DoFHandler::active_cell_iterator cell; + DoFHandler::active_cell_iterator cell; DoFHandler::active_cell_iterator endc = dofs->end(); QTrapez<1> q_trapez; @@ -543,7 +543,7 @@ DoFHandler::active_cell_iterator cell; }; -break; + break; default: Assert (false, ExcNotImplemented()); @@ -610,7 +610,7 @@ void DataOut_Old::write_gnuplot_draft (ostream &out) const }; -DoFHandler::active_cell_iterator cell; + DoFHandler::active_cell_iterator cell; DoFHandler::active_cell_iterator endc = dofs->end(); unsigned int cell_index=0; @@ -748,7 +748,7 @@ DoFHandler::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::EpsCellData>::iterator c=cells.begin();c!=cells.end();++c) + for (multiset::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::EpsCellData>::iterator c=cells.begin(); c!=cells.end(); ++c) { @@ -1158,7 +1159,7 @@ void DataOut_Old::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::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::write_gmv (ostream &out) const }; -/////////////////////////////////////// + /////////////////////////////////////// // data output. out << "variable" << endl; @@ -1333,7 +1334,7 @@ void DataOut_Old::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) { diff --git a/deal.II/deal.II/source/numerics/data_out_stack.cc b/deal.II/deal.II/source/numerics/data_out_stack.cc index c26d11dc13..747d359aab 100644 --- a/deal.II/deal.II/source/numerics/data_out_stack.cc +++ b/deal.II/deal.II/source/numerics/data_out_stack.cc @@ -189,7 +189,7 @@ void DataOutStack::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::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 diff --git a/deal.II/deal.II/source/numerics/histogram.cc b/deal.II/deal.II/source/numerics/histogram.cc index 47a1c9ed66..eac882012d 100644 --- a/deal.II/deal.II/source/numerics/histogram.cc +++ b/deal.II/deal.II/source/numerics/histogram.cc @@ -96,7 +96,7 @@ void Histogram::evaluate (const vector > &values, ); -for (unsigned int i=1; i::const_iterator p=values[i].begin(); p < values[i].end(); ++p) diff --git a/deal.II/deal.II/source/numerics/solution_transfer.cc b/deal.II/deal.II/source/numerics/solution_transfer.cc index 9c8555308c..6602941f16 100644 --- a/deal.II/deal.II/source/numerics/solution_transfer.cc +++ b/deal.II/deal.II/source/numerics/solution_transfer.cc @@ -202,7 +202,7 @@ prepare_for_coarsening_and_refinement(const vector > &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 > &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 local_values(dofs_per_cell); vector *indexptr; diff --git a/deal.II/deal.II/source/numerics/vectors.cc b/deal.II/deal.II/source/numerics/vectors.cc index fbc735a53d..e988a14fbf 100644 --- a/deal.II/deal.II/source/numerics/vectors.cc +++ b/deal.II/deal.II/source/numerics/vectors.cc @@ -956,7 +956,7 @@ VectorTools::integrate_difference (const DoFHandler &dof, }; -// append result of this cell + // append result of this cell // to the end of the vector difference(index) = diff; };