From: heister Date: Thu, 20 Dec 2012 22:07:15 +0000 (+0000) Subject: make indent X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=72613c0ff613d51b944b8eb3baa24945c8c65a7b;p=dealii-svn.git make indent git-svn-id: https://svn.dealii.org/branches/branch_merge_mg_into_dof_handler@27836 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/fe/fe_system.h b/deal.II/include/deal.II/fe/fe_system.h index d80aa71848..c6c8578985 100644 --- a/deal.II/include/deal.II/fe/fe_system.h +++ b/deal.II/include/deal.II/fe/fe_system.h @@ -806,8 +806,8 @@ private: * copies around will then delete the pointer to the base elements. */ std::vector >, - unsigned int> > - base_elements; + unsigned int> > + base_elements; /** diff --git a/deal.II/include/deal.II/meshworker/integration_info.h b/deal.II/include/deal.II/meshworker/integration_info.h index e81efbf21f..a57459f2db 100644 --- a/deal.II/include/deal.II/meshworker/integration_info.h +++ b/deal.II/include/deal.II/meshworker/integration_info.h @@ -740,8 +740,8 @@ namespace MeshWorker if (pc != 0) fevalv[i] = std_cxx1x::shared_ptr > ( - new FEValues (pc->get_mapping(), pc->get_fe(), - pc->get_quadrature(), pc->get_update_flags())); + new FEValues (pc->get_mapping(), pc->get_fe(), + pc->get_quadrature(), pc->get_update_flags())); else if (pf != 0) fevalv[i] = std_cxx1x::shared_ptr > ( new FEFaceValues (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 > ( - new FEValues (pc->get_mapping(), pc->get_fe(), - pc->get_quadrature(), pc->get_update_flags())); + new FEValues (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 > ( - new FEValues (pc->get_mapping(), pc->get_fe(), - pc->get_quadrature(), pc->get_update_flags())); + new FEValues (pc->get_mapping(), pc->get_fe(), + pc->get_quadrature(), pc->get_update_flags())); else if (pf != 0) { Assert (false, ExcImpossibleInDim(1)); diff --git a/deal.II/source/base/quadrature.cc b/deal.II/source/base/quadrature.cc index 08f8a518de..df037e405f 100644 --- a/deal.II/source/base/quadrature.cc +++ b/deal.II/source/base/quadrature.cc @@ -1248,24 +1248,24 @@ subface (const unsigned int face_no, // face_orientation=false; face_flip=false; face_rotation=false and true { 4*GeometryInfo::faces_per_cell*total_subfaces_per_face, - 5*GeometryInfo::faces_per_cell*total_subfaces_per_face + 5*GeometryInfo::faces_per_cell *total_subfaces_per_face }, // face_orientation=false; face_flip=true; face_rotation=false and true { 6*GeometryInfo::faces_per_cell*total_subfaces_per_face, - 7*GeometryInfo::faces_per_cell*total_subfaces_per_face + 7*GeometryInfo::faces_per_cell *total_subfaces_per_face } }, { // face_orientation=true; face_flip=false; face_rotation=false and true { 0*GeometryInfo::faces_per_cell*total_subfaces_per_face, - 1*GeometryInfo::faces_per_cell*total_subfaces_per_face + 1*GeometryInfo::faces_per_cell *total_subfaces_per_face }, // face_orientation=true; face_flip=true; face_rotation=false and true { 2*GeometryInfo::faces_per_cell*total_subfaces_per_face, - 3*GeometryInfo::faces_per_cell*total_subfaces_per_face + 3*GeometryInfo::faces_per_cell *total_subfaces_per_face } } }; diff --git a/deal.II/source/dofs/dof_handler_policy.cc b/deal.II/source/dofs/dof_handler_policy.cc index 65b801e371..b9e1a05f0f 100644 --- a/deal.II/source/dofs/dof_handler_policy.cc +++ b/deal.II/source/dofs/dof_handler_policy.cc @@ -2128,10 +2128,10 @@ namespace internal Assert (false, ExcNotImplemented()); #else - // TODO: distributed geometric multigrid is not complete yet + // TODO: distributed geometric multigrid is not complete yet Assert (false, ExcNotImplemented()); - return false; - + return false; + parallel::distributed::Triangulation< dim, spacedim > *tr = (dynamic_cast*> (const_cast*> diff --git a/deal.II/source/fe/fe_system.cc b/deal.II/source/fe/fe_system.cc index 5854d2c3dd..88048074d2 100644 --- a/deal.II/source/fe/fe_system.cc +++ b/deal.II/source/fe/fe_system.cc @@ -1855,9 +1855,9 @@ void FESystem::initialize (const std::vector0) { base_elements[ind] = - std::make_pair (std_cxx1x::shared_ptr > - (fes[i]->clone()), - multiplicities[i]); + std::make_pair (std_cxx1x::shared_ptr > + (fes[i]->clone()), + multiplicities[i]); ++ind; } } diff --git a/deal.II/source/fe/fe_values.cc b/deal.II/source/fe/fe_values.cc index b64b82b257..05bc1281f6 100644 --- a/deal.II/source/fe/fe_values.cc +++ b/deal.II/source/fe/fe_values.cc @@ -104,7 +104,7 @@ namespace FEValuesViews // variables from FEValuesData, but they aren't initialized yet // at the time we get here, so re-create it all const std::vector shape_function_to_row_table - = make_shape_function_to_row_table (*fe_values.fe); + = make_shape_function_to_row_table (*fe_values.fe); for (unsigned int i=0; idofs_per_cell; ++i) { @@ -113,16 +113,16 @@ namespace FEValuesViews if (is_primitive == true) shape_function_data[i].is_nonzero_shape_function_component - = (component == - fe_values.fe->system_to_component_index(i).first); + = (component == + fe_values.fe->system_to_component_index(i).first); else shape_function_data[i].is_nonzero_shape_function_component - = (fe_values.fe->get_nonzero_components(i)[component] - == true); + = (fe_values.fe->get_nonzero_components(i)[component] + == true); if (shape_function_data[i].is_nonzero_shape_function_component == true) shape_function_data[i].row_index - = shape_function_to_row_table[i*fe_values.fe->n_components()+component]; + = shape_function_to_row_table[i*fe_values.fe->n_components()+component]; else shape_function_data[i].row_index = numbers::invalid_unsigned_int; } @@ -165,7 +165,7 @@ namespace FEValuesViews // variables from FEValuesData, but they aren't initialized yet // at the time we get here, so re-create it all const std::vector shape_function_to_row_table - = make_shape_function_to_row_table (*fe_values.fe); + = make_shape_function_to_row_table (*fe_values.fe); for (unsigned int d=0; dsystem_to_component_index(i).first); + = (component == + fe_values.fe->system_to_component_index(i).first); else shape_function_data[i].is_nonzero_shape_function_component[d] - = (fe_values.fe->get_nonzero_components(i)[component] - == true); + = (fe_values.fe->get_nonzero_components(i)[component] + == true); if (shape_function_data[i].is_nonzero_shape_function_component[d] == true) shape_function_data[i].row_index[d] - = shape_function_to_row_table[i*fe_values.fe->n_components()+component]; + = shape_function_to_row_table[i*fe_values.fe->n_components()+component]; else shape_function_data[i].row_index[d] - = numbers::invalid_unsigned_int; + = numbers::invalid_unsigned_int; } } @@ -214,9 +214,9 @@ namespace FEValuesViews == true) { shape_function_data[i].single_nonzero_component - = shape_function_data[i].row_index[d]; + = shape_function_data[i].row_index[d]; shape_function_data[i].single_nonzero_component_index - = d; + = d; break; } } @@ -263,7 +263,7 @@ namespace FEValuesViews // variables from FEValuesData, but they aren't initialized yet // at the time we get here, so re-create it all const std::vector shape_function_to_row_table - = make_shape_function_to_row_table (*fe_values.fe); + = make_shape_function_to_row_table (*fe_values.fe); for (unsigned int d = 0; d < dealii::SymmetricTensor<2,dim>::n_independent_components; ++d) { @@ -276,20 +276,20 @@ namespace FEValuesViews if (is_primitive == true) shape_function_data[i].is_nonzero_shape_function_component[d] - = (component == - fe_values.fe->system_to_component_index(i).first); + = (component == + fe_values.fe->system_to_component_index(i).first); else shape_function_data[i].is_nonzero_shape_function_component[d] - = (fe_values.fe->get_nonzero_components(i)[component] - == true); + = (fe_values.fe->get_nonzero_components(i)[component] + == true); if (shape_function_data[i].is_nonzero_shape_function_component[d] == true) shape_function_data[i].row_index[d] - = shape_function_to_row_table[i*fe_values.fe->n_components()+component]; + = shape_function_to_row_table[i*fe_values.fe->n_components()+component]; else shape_function_data[i].row_index[d] - = numbers::invalid_unsigned_int; + = numbers::invalid_unsigned_int; } } @@ -312,9 +312,9 @@ namespace FEValuesViews == true) { shape_function_data[i].single_nonzero_component - = shape_function_data[i].row_index[d]; + = shape_function_data[i].row_index[d]; shape_function_data[i].single_nonzero_component_index - = d; + = d; break; } } @@ -1057,7 +1057,7 @@ namespace FEValuesViews dealii::Vector dof_values(fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_values - (dof_values, fe_values.shape_values, shape_function_data, values); + (dof_values, fe_values.shape_values, shape_function_data, values); } @@ -1081,7 +1081,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_derivatives<1,dim,spacedim> - (dof_values, fe_values.shape_gradients, shape_function_data, gradients); + (dof_values, fe_values.shape_gradients, shape_function_data, gradients); } @@ -1105,7 +1105,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_derivatives<2,dim,spacedim> - (dof_values, fe_values.shape_hessians, shape_function_data, hessians); + (dof_values, fe_values.shape_hessians, shape_function_data, hessians); } @@ -1129,7 +1129,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_laplacians - (dof_values, fe_values.shape_hessians, shape_function_data, laplacians); + (dof_values, fe_values.shape_hessians, shape_function_data, laplacians); } @@ -1153,7 +1153,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_values - (dof_values, fe_values.shape_values, shape_function_data, values); + (dof_values, fe_values.shape_values, shape_function_data, values); } @@ -1178,7 +1178,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_derivatives<1,dim,spacedim> - (dof_values, fe_values.shape_gradients, shape_function_data, gradients); + (dof_values, fe_values.shape_gradients, shape_function_data, gradients); } @@ -1202,8 +1202,8 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_symmetric_gradients - (dof_values, fe_values.shape_gradients, shape_function_data, - symmetric_gradients); + (dof_values, fe_values.shape_gradients, shape_function_data, + symmetric_gradients); } @@ -1228,7 +1228,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_divergences - (dof_values, fe_values.shape_gradients, shape_function_data, divergences); + (dof_values, fe_values.shape_gradients, shape_function_data, divergences); } template @@ -1251,7 +1251,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values (fe_function, dof_values); internal::do_function_curls - (dof_values, fe_values.shape_gradients, shape_function_data, curls); + (dof_values, fe_values.shape_gradients, shape_function_data, curls); } @@ -1274,7 +1274,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_derivatives<2,dim,spacedim> - (dof_values, fe_values.shape_hessians, shape_function_data, hessians); + (dof_values, fe_values.shape_hessians, shape_function_data, hessians); } @@ -1301,7 +1301,7 @@ namespace FEValuesViews dealii::Vector dof_values (fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_laplacians - (dof_values, fe_values.shape_hessians, shape_function_data, laplacians); + (dof_values, fe_values.shape_hessians, shape_function_data, laplacians); } @@ -1325,7 +1325,7 @@ namespace FEValuesViews dealii::Vector dof_values(fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_values - (dof_values, fe_values.shape_values, shape_function_data, values); + (dof_values, fe_values.shape_values, shape_function_data, values); } @@ -1350,7 +1350,7 @@ namespace FEValuesViews dealii::Vector dof_values(fe_values.dofs_per_cell); fe_values.present_cell->get_interpolated_dof_values(fe_function, dof_values); internal::do_function_divergences - (dof_values, fe_values.shape_gradients, shape_function_data, divergences); + (dof_values, fe_values.shape_gradients, shape_function_data, divergences); } } @@ -1414,9 +1414,9 @@ namespace internal // compute number of symmetric // tensors in the same way as above const unsigned int n_symmetric_second_order_tensors - = (fe.n_components() >= (dim*dim + dim)/2 ? - fe.n_components() - (dim*dim + dim)/2 + 1 : - 0); + = (fe.n_components() >= (dim*dim + dim)/2 ? + fe.n_components() - (dim*dim + dim)/2 + 1 : + 0); symmetric_second_order_tensors.resize(n_symmetric_second_order_tensors); for (unsigned int component = 0; component < n_symmetric_second_order_tensors; ++component) { @@ -1739,13 +1739,13 @@ get_interpolated_dof_values (const IndexSet &in, template const char *const FEValuesBase::TriaCellIterator::message_string -= ("You have previously called the FEValues::reinit function with a\n" - "cell iterator of type Triangulation::cell_iterator. However,\n" - "when you do this, you cannot call some functions in the FEValues\n" - "class, such as the get_function_values/gradients/hessians\n" - "functions. If you need these functions, then you need to call\n" - "FEValues::reinit with an iterator type that allows to extract\n" - "degrees of freedom, such as DoFHandler::cell_iterator."); + = ("You have previously called the FEValues::reinit function with a\n" + "cell iterator of type Triangulation::cell_iterator. However,\n" + "when you do this, you cannot call some functions in the FEValues\n" + "class, such as the get_function_values/gradients/hessians\n" + "functions. If you need these functions, then you need to call\n" + "FEValues::reinit with an iterator type that allows to extract\n" + "degrees of freedom, such as DoFHandler::cell_iterator."); template @@ -1806,7 +1806,7 @@ FEValuesData::initialize (const unsigned int n_quadrature_p // the data by shape function and // nonzero component this->shape_function_to_row_table - = make_shape_function_to_row_table (fe); + = make_shape_function_to_row_table (fe); // count the total number of non-zero // components accumulated over all shape @@ -2075,7 +2075,7 @@ namespace internal continue; const Tensor *shape_derivative_ptr - = &shape_derivatives[shape_func][0]; + = &shape_derivatives[shape_func][0]; for (unsigned int point=0; point *shape_hessian_ptr - = &shape_hessians[shape_func][0]; + = &shape_hessians[shape_func][0]; for (unsigned int point=0; point