From: heister Date: Fri, 21 Dec 2012 02:54:58 +0000 (+0000) Subject: revert whitespace changes X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=487275f264e87507c840a81a019228860b5dbe0b;p=dealii-svn.git revert whitespace changes git-svn-id: https://svn.dealii.org/branches/branch_merge_mg_into_dof_handler@27849 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/dofs/dof_handler_policy.h b/deal.II/include/deal.II/dofs/dof_handler_policy.h index bd3627de3a..2fbbcc7bec 100644 --- a/deal.II/include/deal.II/dofs/dof_handler_policy.h +++ b/deal.II/include/deal.II/dofs/dof_handler_policy.h @@ -81,7 +81,7 @@ namespace internal */ virtual NumberCache - renumber_dofs (const std::vector &new_numbers, + renumber_dofs (const std::vector &new_numbers, dealii::DoFHandler &dof_handler) const = 0; }; @@ -118,7 +118,7 @@ namespace internal */ virtual NumberCache - renumber_dofs (const std::vector &new_numbers, + renumber_dofs (const std::vector &new_numbers, dealii::DoFHandler &dof_handler) const; }; @@ -156,7 +156,7 @@ namespace internal */ virtual NumberCache - renumber_dofs (const std::vector &new_numbers, + renumber_dofs (const std::vector &new_numbers, dealii::DoFHandler &dof_handler) const; }; } diff --git a/deal.II/include/deal.II/dofs/dof_renumbering.h b/deal.II/include/deal.II/dofs/dof_renumbering.h index b0431b59e2..93c3c1b8c7 100644 --- a/deal.II/include/deal.II/dofs/dof_renumbering.h +++ b/deal.II/include/deal.II/dofs/dof_renumbering.h @@ -891,7 +891,7 @@ namespace DoFRenumbering */ template void - block_wise (MGDoFHandler &dof_handler, + block_wise (MGDoFHandler &dof_handler, const unsigned int level); diff --git a/deal.II/include/deal.II/dofs/dof_tools.h b/deal.II/include/deal.II/dofs/dof_tools.h index 489358a976..432b04b2b8 100644 --- a/deal.II/include/deal.II/dofs/dof_tools.h +++ b/deal.II/include/deal.II/dofs/dof_tools.h @@ -1283,7 +1283,7 @@ namespace DoFTools template void distribute_cell_to_dof_vector (const DH &dof_handler, - const Vector &cell_data, + const Vector &cell_data, Vector &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 &selected_dofs); + std::vector &selected_dofs); /** @@ -2283,7 +2283,7 @@ namespace DoFTools void count_dofs_per_block (const DH &dof, std::vector &dofs_per_block, - const std::vector &target_block + const std::vector &target_block = std::vector()); /** @@ -2586,7 +2586,7 @@ namespace DoFTools template void map_dof_to_boundary_indices (const DH &dof_handler, - std::vector &mapping); + std::vector &mapping); /** * Same as the previous function, diff --git a/deal.II/include/deal.II/fe/fe_values.h b/deal.II/include/deal.II/fe/fe_values.h index 708250c034..33a8e9b543 100644 --- a/deal.II/include/deal.II/fe/fe_values.h +++ b/deal.II/include/deal.II/fe/fe_values.h @@ -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, diff --git a/deal.II/include/deal.II/hp/dof_handler.h b/deal.II/include/deal.II/hp/dof_handler.h index 9f4ed86563..32fbed9f02 100644 --- a/deal.II/include/deal.II/hp/dof_handler.h +++ b/deal.II/include/deal.II/hp/dof_handler.h @@ -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 diff --git a/deal.II/include/deal.II/hp/fe_values.h b/deal.II/include/deal.II/hp/fe_values.h index 51377aba2d..eb886a0c44 100644 --- a/deal.II/include/deal.II/hp/fe_values.h +++ b/deal.II/include/deal.II/hp/fe_values.h @@ -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 &mapping_collection, const dealii::hp::FECollection &fe_collection, const dealii::hp::QCollection &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 &fe_collection, const dealii::hp::QCollection &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 & 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 - * hp::FE*Values 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 + * hp::FE*Values 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, FEValuesBase > fe_collection; /** - * A pointer to the - * collection of mappings to - * be used. - */ + * A pointer to the + * collection of mappings to + * be used. + */ const SmartPointer, FEValuesBase > 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_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 > 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 &mapping_collection, - const dealii::hp::FECollection &fe_collection, + const dealii::hp::FECollection &fe_collection, const dealii::hp::QCollection &q_collection, const UpdateFlags update_flags); @@ -501,7 +501,7 @@ namespace hp * function. */ FEFaceValues (const hp::MappingCollection &mapping_collection, - const hp::FECollection &fe_collection, + const hp::FECollection &fe_collection, const hp::QCollection &q_collection, const UpdateFlags update_flags); @@ -528,7 +528,7 @@ namespace hp * DoFHandler::get_fe() * function. */ - FEFaceValues (const hp::FECollection &fe_collection, + FEFaceValues (const hp::FECollection &fe_collection, const hp::QCollection &q_collection, const UpdateFlags update_flags); @@ -711,7 +711,7 @@ namespace hp * function. */ FESubfaceValues (const hp::MappingCollection &mapping_collection, - const hp::FECollection &fe_collection, + const hp::FECollection &fe_collection, const hp::QCollection &q_collection, const UpdateFlags update_flags); diff --git a/deal.II/include/deal.II/matrix_free/matrix_free.h b/deal.II/include/deal.II/matrix_free/matrix_free.h index c5b8ea394b..0b86a9bb42 100644 --- a/deal.II/include/deal.II/matrix_free/matrix_free.h +++ b/deal.II/include/deal.II/matrix_free/matrix_free.h @@ -1925,7 +1925,7 @@ template template void MatrixFree:: reinit(const Mapping &mapping, - const std::vector &dof_handler, + const std::vector &dof_handler, const std::vector &constraint, const std::vector &quad, const MatrixFree::AdditionalData additional_data) @@ -1983,7 +1983,7 @@ namespace internal template inline - void update_ghost_values_start (const parallel::distributed::Vector &src, + void update_ghost_values_start (const parallel::distributed::Vector &src, const unsigned int channel = 0) { src.update_ghost_values_start(channel); @@ -1993,7 +1993,7 @@ namespace internal template inline - void update_ghost_values_start (const std::vector &src) + void update_ghost_values_start (const std::vector &src) { for (unsigned int comp=0; comp inline - void update_ghost_values_start (const std::vector &src) + void update_ghost_values_start (const std::vector &src) { for (unsigned int comp=0; comp inline - void update_ghost_values_finish (const parallel::distributed::Vector &src) + void update_ghost_values_finish (const parallel::distributed::Vector &src) { src.update_ghost_values_finish(); } @@ -2029,7 +2029,7 @@ namespace internal template inline - void update_ghost_values_finish (const std::vector &src) + void update_ghost_values_finish (const std::vector &src) { for (unsigned int comp=0; comp inline - void update_ghost_values_finish (const std::vector &src) + void update_ghost_values_finish (const std::vector &src) { for (unsigned int comp=0; comp::cell_loop const std::pair &)> &cell_operation, OutVector &dst, - const InVector &src) const + const InVector &src) const { #if DEAL_II_USE_MT==1 diff --git a/deal.II/include/deal.II/multigrid/mg_dof_handler.h b/deal.II/include/deal.II/multigrid/mg_dof_handler.h index e7b872039f..148dc9670a 100644 --- a/deal.II/include/deal.II/multigrid/mg_dof_handler.h +++ b/deal.II/include/deal.II/multigrid/mg_dof_handler.h @@ -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 &tria); /** - * Destructor - */ + * Destructor + */ virtual ~MGDoFHandler (); /** diff --git a/deal.II/include/deal.II/multigrid/mg_tools.h b/deal.II/include/deal.II/multigrid/mg_tools.h index e628e42b0b..102d1d4e2e 100644 --- a/deal.II/include/deal.II/multigrid/mg_tools.h +++ b/deal.II/include/deal.II/multigrid/mg_tools.h @@ -233,7 +233,7 @@ namespace MGTools void make_boundary_list (const DoFHandler &mg_dof, const typename FunctionMap::type &function_map, - std::vector > &boundary_indices, + std::vector > &boundary_indices, const ComponentMask &component_mask = ComponentMask()); /** @@ -286,8 +286,8 @@ namespace MGTools template void extract_inner_interface_dofs (const DoFHandler &mg_dof_handler, - std::vector > &interface_dofs, - std::vector > &boundary_interface_dofs); + std::vector > &interface_dofs, + std::vector > &boundary_interface_dofs); /** * Does the same as the function above, @@ -296,12 +296,12 @@ namespace MGTools template void extract_inner_interface_dofs (const DoFHandler &mg_dof_handler, - std::vector > &interface_dofs); + std::vector > &interface_dofs); template void extract_non_interface_dofs (const DoFHandler &mg_dof_handler, - std::vector > &non_interface_dofs); + std::vector > &non_interface_dofs); } /* @} */ diff --git a/deal.II/source/dofs/dof_handler_policy.cc b/deal.II/source/dofs/dof_handler_policy.cc index 9c9316f256..49c11f4ac1 100644 --- a/deal.II/source/dofs/dof_handler_policy.cc +++ b/deal.II/source/dofs/dof_handler_policy.cc @@ -922,7 +922,7 @@ namespace internal template NumberCache Sequential:: - renumber_dofs (const std::vector &new_numbers, + renumber_dofs (const std::vector &new_numbers, dealii::DoFHandler &dof_handler) const { Implementation::renumber_dofs (new_numbers, IndexSet(0), diff --git a/deal.II/source/dofs/dof_renumbering.inst.in b/deal.II/source/dofs/dof_renumbering.inst.in index 1c0c769516..fcfc82d843 100644 --- a/deal.II/source/dofs/dof_renumbering.inst.in +++ b/deal.II/source/dofs/dof_renumbering.inst.in @@ -140,7 +140,7 @@ namespace DoFRenumbering const bool, const bool, const std::vector&); - + template void component_wise (hp::DoFHandler&, diff --git a/deal.II/source/dofs/dof_tools.cc b/deal.II/source/dofs/dof_tools.cc index 43234a5ab0..7139210eef 100644 --- a/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/source/dofs/dof_tools.cc @@ -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 std::vector - get_local_component_association (const FiniteElement &fe, + get_local_component_association (const FiniteElement &fe, const ComponentMask &component_mask) { std::vector local_component_association (fe.dofs_per_cell, @@ -4320,7 +4320,7 @@ namespace DoFTools void resolve_components (const FiniteElement &fe, const std::vector &dofs_by_component, - const std::vector &target_component, + const std::vector &target_component, const bool only_once, std::vector &dofs_per_component, unsigned int &component) @@ -4361,7 +4361,7 @@ namespace DoFTools void resolve_components (const hp::FECollection &fe_collection, const std::vector &dofs_by_component, - const std::vector &target_component, + const std::vector &target_component, const bool only_once, std::vector &dofs_per_component, unsigned int &component) @@ -4508,7 +4508,7 @@ namespace DoFTools void count_dofs_per_block (const DH &dof_handler, std::vector &dofs_per_block, - const std::vector &target_block_) + const std::vector &target_block_) { std::vector target_block = target_block_; @@ -5349,11 +5349,11 @@ namespace DoFTools { namespace { - template + template void map_dofs_to_support_points(const hp::MappingCollection &mapping, - const DH &dof_handler, - std::map > &support_points) + const DH &dof_handler, + std::map > &support_points) { const unsigned int dim = DH::dimension; const unsigned int spacedim = DH::space_dimension; @@ -5406,8 +5406,8 @@ namespace DoFTools template void map_dofs_to_support_points(const hp::MappingCollection &mapping, - const DH &dof_handler, - std::vector > &support_points) + const DH &dof_handler, + std::vector > &support_points) { // get the data in the form of the map as above std::map > x_support_points; diff --git a/deal.II/source/fe/mapping_q1_eulerian.cc b/deal.II/source/fe/mapping_q1_eulerian.cc index a2a73a7776..9ec2a9708f 100644 --- a/deal.II/source/fe/mapping_q1_eulerian.cc +++ b/deal.II/source/fe/mapping_q1_eulerian.cc @@ -25,7 +25,7 @@ DEAL_II_NAMESPACE_OPEN template MappingQ1Eulerian:: -MappingQ1Eulerian (const EulerVectorType &euler_transform_vectors, +MappingQ1Eulerian (const EulerVectorType &euler_transform_vectors, const DoFHandler &shiftmap_dof_handler) : euler_transform_vectors(&euler_transform_vectors), diff --git a/deal.II/source/hp/fe_values.cc b/deal.II/source/hp/fe_values.cc index 3e43ff6ce6..c66e4b0225 100644 --- a/deal.II/source/hp/fe_values.cc +++ b/deal.II/source/hp/fe_values.cc @@ -232,7 +232,7 @@ namespace hp template FEFaceValues::FEFaceValues (const hp::MappingCollection &mapping, - const hp::FECollection &fe_collection, + const hp::FECollection &fe_collection, const hp::QCollection &q_collection, const UpdateFlags update_flags) : @@ -244,7 +244,7 @@ namespace hp template - FEFaceValues::FEFaceValues (const hp::FECollection &fe_collection, + FEFaceValues::FEFaceValues (const hp::FECollection &fe_collection, const hp::QCollection &q_collection, const UpdateFlags update_flags) : @@ -351,7 +351,7 @@ namespace hp template FESubfaceValues::FESubfaceValues (const hp::MappingCollection &mapping, - const hp::FECollection &fe_collection, + const hp::FECollection &fe_collection, const hp::QCollection &q_collection, const UpdateFlags update_flags) : @@ -363,7 +363,7 @@ namespace hp template - FESubfaceValues::FESubfaceValues (const hp::FECollection &fe_collection, + FESubfaceValues::FESubfaceValues (const hp::FECollection &fe_collection, const hp::QCollection &q_collection, const UpdateFlags update_flags) : diff --git a/deal.II/source/lac/trilinos_sparse_matrix.cc b/deal.II/source/lac/trilinos_sparse_matrix.cc index bc8b1321be..25b5f1ce56 100644 --- a/deal.II/source/lac/trilinos_sparse_matrix.cc +++ b/deal.II/source/lac/trilinos_sparse_matrix.cc @@ -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 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