From 656089f43e8689273078a9478c745e61ec6bb283 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Thu, 23 Jul 2015 17:21:27 -0500 Subject: [PATCH] Cosmetic changes. There's a show on TV as I write on cosmetic surgery. I thought I'd do some of my own in a couple of places I found over the past few days. --- include/deal.II/fe/fe_dgp_nonparametric.h | 6 +++--- include/deal.II/fe/fe_face.h | 10 +++++----- include/deal.II/fe/fe_poly.h | 6 +++--- include/deal.II/fe/fe_poly_face.h | 10 +++++----- include/deal.II/fe/fe_poly_tensor.h | 6 +++--- include/deal.II/fe/fe_system.h | 6 +++--- include/deal.II/fe/mapping_cartesian.h | 6 +++--- include/deal.II/fe/mapping_fe_field.h | 6 +++--- include/deal.II/fe/mapping_q.h | 6 +++--- include/deal.II/fe/mapping_q1.h | 4 ++-- include/deal.II/grid/tria_boundary_lib.h | 14 +++++++------- 11 files changed, 40 insertions(+), 40 deletions(-) diff --git a/include/deal.II/fe/fe_dgp_nonparametric.h b/include/deal.II/fe/fe_dgp_nonparametric.h index cbca0ffbf6..6dd38bdbd4 100644 --- a/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/include/deal.II/fe/fe_dgp_nonparametric.h @@ -527,7 +527,7 @@ protected: typename Mapping::InternalDataBase * get_data (const UpdateFlags, const Mapping &mapping, - const Quadrature &quadrature) const ; + const Quadrature &quadrature) const; /** * Implementation of the same function in FiniteElement. @@ -551,7 +551,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; /** * Implementation of the same function in FiniteElement. @@ -564,7 +564,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; private: diff --git a/include/deal.II/fe/fe_face.h b/include/deal.II/fe/fe_face.h index b2442d7eb9..da5f3ddc99 100644 --- a/include/deal.II/fe/fe_face.h +++ b/include/deal.II/fe/fe_face.h @@ -231,17 +231,17 @@ protected: typename Mapping<1,spacedim>::InternalDataBase * get_data (const UpdateFlags, const Mapping<1,spacedim> &mapping, - const Quadrature<1> &quadrature) const ; + const Quadrature<1> &quadrature) const; typename Mapping<1,spacedim>::InternalDataBase * get_face_data (const UpdateFlags, const Mapping<1,spacedim> &mapping, - const Quadrature<0> &quadrature) const ; + const Quadrature<0> &quadrature) const; typename Mapping<1,spacedim>::InternalDataBase * get_subface_data (const UpdateFlags, const Mapping<1,spacedim> &mapping, - const Quadrature<0> &quadrature) const ; + const Quadrature<0> &quadrature) const; virtual void fill_fe_values (const Mapping<1,spacedim> &mapping, @@ -259,7 +259,7 @@ protected: const Quadrature<0> &quadrature, const typename Mapping<1,spacedim>::InternalDataBase &mapping_internal, const typename Mapping<1,spacedim>::InternalDataBase &fe_internal, - FEValuesData<1,spacedim> &data) const ; + FEValuesData<1,spacedim> &data) const; virtual void fill_fe_subface_values (const Mapping<1,spacedim> &mapping, @@ -269,7 +269,7 @@ protected: const Quadrature<0> &quadrature, const typename Mapping<1,spacedim>::InternalDataBase &mapping_internal, const typename Mapping<1,spacedim>::InternalDataBase &fe_internal, - FEValuesData<1,spacedim> &data) const ; + FEValuesData<1,spacedim> &data) const; /** diff --git a/include/deal.II/fe/fe_poly.h b/include/deal.II/fe/fe_poly.h index 68cec5a107..b82cf5b530 100644 --- a/include/deal.II/fe/fe_poly.h +++ b/include/deal.II/fe/fe_poly.h @@ -166,7 +166,7 @@ protected: typename Mapping::InternalDataBase * get_data (const UpdateFlags, const Mapping &mapping, - const Quadrature &quadrature) const ; + const Quadrature &quadrature) const; virtual void fill_fe_values (const Mapping &mapping, @@ -184,7 +184,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; virtual void fill_fe_subface_values (const Mapping &mapping, @@ -194,7 +194,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; /** diff --git a/include/deal.II/fe/fe_poly_face.h b/include/deal.II/fe/fe_poly_face.h index 574df43aff..8f370c363f 100644 --- a/include/deal.II/fe/fe_poly_face.h +++ b/include/deal.II/fe/fe_poly_face.h @@ -144,17 +144,17 @@ protected: typename Mapping::InternalDataBase * get_data (const UpdateFlags, const Mapping &mapping, - const Quadrature &quadrature) const ; + const Quadrature &quadrature) const; typename Mapping::InternalDataBase * get_face_data (const UpdateFlags, const Mapping &mapping, - const Quadrature& quadrature) const ; + const Quadrature& quadrature) const; typename Mapping::InternalDataBase * get_subface_data (const UpdateFlags, const Mapping &mapping, - const Quadrature& quadrature) const ; + const Quadrature& quadrature) const; virtual void fill_fe_values (const Mapping &mapping, @@ -172,7 +172,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; virtual void fill_fe_subface_values (const Mapping &mapping, @@ -182,7 +182,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; /** diff --git a/include/deal.II/fe/fe_poly_tensor.h b/include/deal.II/fe/fe_poly_tensor.h index 7922b709e6..15198386cb 100644 --- a/include/deal.II/fe/fe_poly_tensor.h +++ b/include/deal.II/fe/fe_poly_tensor.h @@ -179,7 +179,7 @@ protected: typename Mapping::InternalDataBase * get_data (const UpdateFlags, const Mapping &mapping, - const Quadrature &quadrature) const ; + const Quadrature &quadrature) const; virtual void fill_fe_values (const Mapping &mapping, @@ -197,7 +197,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; virtual void fill_fe_subface_values (const Mapping &mapping, @@ -207,7 +207,7 @@ protected: const Quadrature &quadrature, const typename Mapping::InternalDataBase &mapping_internal, const typename Mapping::InternalDataBase &fe_internal, - FEValuesData &data) const ; + FEValuesData &data) const; /** * Fields of cell-independent data for FE_PolyTensor. Stores the values of diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index 085d9bd5bc..578fd8c38d 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -800,17 +800,17 @@ protected: virtual typename Mapping::InternalDataBase * get_data (const UpdateFlags update_flags, const Mapping &mapping, - const Quadrature &quadrature) const ; + const Quadrature &quadrature) const; virtual typename Mapping::InternalDataBase * get_face_data (const UpdateFlags update_flags, const Mapping &mapping, - const Quadrature &quadrature) const ; + const Quadrature &quadrature) const; virtual typename Mapping::InternalDataBase * get_subface_data (const UpdateFlags update_flags, const Mapping &mapping, - const Quadrature &quadrature) const ; + const Quadrature &quadrature) const; /** * Implementation of the same function in FiniteElement. diff --git a/include/deal.II/fe/mapping_cartesian.h b/include/deal.II/fe/mapping_cartesian.h index 57e61bb60f..cb3b7a8505 100644 --- a/include/deal.II/fe/mapping_cartesian.h +++ b/include/deal.II/fe/mapping_cartesian.h @@ -80,7 +80,7 @@ public: std::vector > &jacobian_grads, std::vector > &inverse_jacobians, std::vector > &, - const CellSimilarity::Similarity cell_similarity) const ; + const CellSimilarity::Similarity cell_similarity) const; virtual void @@ -93,7 +93,7 @@ public: std::vector > &boundary_form, std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; virtual void fill_fe_subface_values (const typename Triangulation::cell_iterator &cell, const unsigned int face_no, @@ -105,7 +105,7 @@ public: std::vector > &boundary_form, std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; virtual void transform (const VectorSlice > > input, diff --git a/include/deal.II/fe/mapping_fe_field.h b/include/deal.II/fe/mapping_fe_field.h index 450a617d86..ef07f28480 100644 --- a/include/deal.II/fe/mapping_fe_field.h +++ b/include/deal.II/fe/mapping_fe_field.h @@ -423,7 +423,7 @@ protected: std::vector > &jacobian_grads, std::vector > &inverse_jacobians, std::vector > &cell_normal_vectors, - const CellSimilarity::Similarity cell_similarity) const ; + const CellSimilarity::Similarity cell_similarity) const; /** * Implementation of the interface in Mapping. @@ -438,7 +438,7 @@ protected: std::vector > &exterior_forms, std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; /** * Implementation of the interface in Mapping. @@ -454,7 +454,7 @@ protected: std::vector > &exterior_forms, std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; /** diff --git a/include/deal.II/fe/mapping_q.h b/include/deal.II/fe/mapping_q.h index ff30ce782d..8f1cf79106 100644 --- a/include/deal.II/fe/mapping_q.h +++ b/include/deal.II/fe/mapping_q.h @@ -204,7 +204,7 @@ protected: std::vector > &jacobian_grads, std::vector > &inverse_jacobians, std::vector > &cell_normal_vectors, - const CellSimilarity::Similarity cell_similarity) const ; + const CellSimilarity::Similarity cell_similarity) const; /** * Implementation of the interface in Mapping. @@ -219,7 +219,7 @@ protected: typename std::vector > &exterior_form, typename std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; /** * Implementation of the interface in Mapping. @@ -235,7 +235,7 @@ protected: typename std::vector > &exterior_form, typename std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; /** * For dim=2,3. Append the support points of all shape functions diff --git a/include/deal.II/fe/mapping_q1.h b/include/deal.II/fe/mapping_q1.h index 5ac2510d8b..e4ea497363 100644 --- a/include/deal.II/fe/mapping_q1.h +++ b/include/deal.II/fe/mapping_q1.h @@ -330,7 +330,7 @@ public: typename std::vector > &boundary_form, typename std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; /** * Implementation of the interface in Mapping. @@ -346,7 +346,7 @@ public: typename std::vector > &boundary_form, typename std::vector > &normal_vectors, std::vector > &jacobians, - std::vector > &inverse_jacobians) const ; + std::vector > &inverse_jacobians) const; /** * Compute shape values and/or derivatives. diff --git a/include/deal.II/grid/tria_boundary_lib.h b/include/deal.II/grid/tria_boundary_lib.h index 8e8e8bd0bc..5db8cc92be 100644 --- a/include/deal.II/grid/tria_boundary_lib.h +++ b/include/deal.II/grid/tria_boundary_lib.h @@ -646,14 +646,14 @@ public: */ virtual void get_intermediate_points_on_line ( const typename Triangulation< dim, spacedim >::line_iterator &line, - std::vector< Point< spacedim > > &points) const ; + std::vector< Point< spacedim > > &points) const; /** * Construct a new points on a quad. */ virtual void get_intermediate_points_on_quad ( const typename Triangulation< dim, spacedim >::quad_iterator &quad, - std::vector< Point< spacedim > > &points ) const ; + std::vector< Point< spacedim > > &points ) const; /** * Get the normal from cartesian coordinates. This normal does not have unit @@ -661,7 +661,7 @@ public: */ virtual void get_normals_at_vertices ( const typename Triangulation< dim, spacedim >::face_iterator &face, - typename Boundary::FaceVertexNormals &face_vertex_normals) const ; + typename Boundary::FaceVertexNormals &face_vertex_normals) const; private: //Handy functions @@ -677,25 +677,25 @@ private: * Get the cartesian coordinates of the Torus, i.e., from * (theta,phi) to (x,y,z). */ - Point get_real_coord(const Point &surfP) const ; + Point get_real_coord(const Point &surfP) const; /** * Get the surface coordinates of the Torus, i.e., from (x,y,z) to * (theta,phi). */ - Point get_surf_coord(const Point &p) const ; + Point get_surf_coord(const Point &p) const; /** * Get the normal from surface coordinates. This normal does not have unit * length. */ - Point get_surf_norm_from_sp(const Point &surfP) const ; + Point get_surf_norm_from_sp(const Point &surfP) const; /** * Get the normal from cartesian coordinates. This normal does not have unit * length. */ - Point get_surf_norm(const Point &p) const ; + Point get_surf_norm(const Point &p) const; /** * Inner and outer radii of the shell. -- 2.39.5