]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Comment out unused parameters in source files.
authorDavid Wells <drwells@vt.edu>
Sat, 4 Apr 2015 15:47:41 +0000 (11:47 -0400)
committerMatthias Maier <matthias.maier@iwr.uni-heidelberg.de>
Tue, 14 Apr 2015 10:50:18 +0000 (12:50 +0200)
These are neither used in debug nor release mode.

12 files changed:
source/distributed/tria.cc
source/fe/fe_dgq.cc
source/fe/fe_face.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_q_base.cc
source/grid/grid_generator.cc
source/grid/grid_out.cc
source/grid/manifold.cc
source/lac/petsc_matrix_base.cc
source/numerics/data_postprocessor.cc
source/numerics/matrix_tools.cc
source/opencascade/utilities.cc

index 6602ff31a21ab35b6628ae3e881a39f9e499a8bc..d91c8f8dd5dcb8bff08eab7a56ff6324be51c1cd 100644 (file)
@@ -4437,7 +4437,7 @@ namespace parallel
     template <int spacedim>
     void
     Triangulation<1,spacedim>::communicate_locally_moved_vertices
-    (const std::vector<bool> &vertex_locally_moved)
+    (const std::vector<bool> &/*vertex_locally_moved*/)
     {
       Assert (false, ExcNotImplemented());
     }
@@ -4490,7 +4490,7 @@ namespace parallel
     Triangulation<1,spacedim>::
     fill_vertices_with_ghost_neighbors
     (std::map<unsigned int, std::set<dealii::types::subdomain_id> >
-     &vertices_with_ghost_neighbors)
+     &/*vertices_with_ghost_neighbors*/)
     {
       Assert (false, ExcNotImplemented());
     }
index 7d3468b61bf07926ab6e0c1c6e1909ca2c8f96bc..ce7b60592009df402da169484a0f9e47708bd3da 100644 (file)
@@ -615,7 +615,7 @@ FE_DGQ<dim, spacedim>::hp_constraints_are_implemented () const
 template <int dim, int spacedim>
 std::vector<std::pair<unsigned int, unsigned int> >
 FE_DGQ<dim, spacedim>::
-hp_vertex_dof_identities (const FiniteElement<dim, spacedim> &fe_other) const
+hp_vertex_dof_identities (const FiniteElement<dim, spacedim> &/*fe_other*/) const
 {
   // this element is discontinuous, so by definition there can
   // be no identities between its dofs and those of any neighbor
@@ -630,7 +630,7 @@ hp_vertex_dof_identities (const FiniteElement<dim, spacedim> &fe_other) const
 template <int dim, int spacedim>
 std::vector<std::pair<unsigned int, unsigned int> >
 FE_DGQ<dim, spacedim>::
-hp_line_dof_identities (const FiniteElement<dim, spacedim> &fe_other) const
+hp_line_dof_identities (const FiniteElement<dim, spacedim> &/*fe_other*/) const
 {
   // this element is discontinuous, so by definition there can
   // be no identities between its dofs and those of any neighbor
@@ -645,7 +645,7 @@ hp_line_dof_identities (const FiniteElement<dim, spacedim> &fe_other) const
 template <int dim, int spacedim>
 std::vector<std::pair<unsigned int, unsigned int> >
 FE_DGQ<dim, spacedim>::
-hp_quad_dof_identities (const FiniteElement<dim, spacedim>        &fe_other) const
+hp_quad_dof_identities (const FiniteElement<dim, spacedim> &/*fe_other*/) const
 {
   // this element is discontinuous, so by definition there can
   // be no identities between its dofs and those of any neighbor
@@ -659,7 +659,7 @@ hp_quad_dof_identities (const FiniteElement<dim, spacedim>        &fe_other) con
 
 template <int dim, int spacedim>
 FiniteElementDomination::Domination
-FE_DGQ<dim, spacedim>::compare_for_face_domination (const FiniteElement<dim, spacedim> &fe_other) const
+FE_DGQ<dim, spacedim>::compare_for_face_domination (const FiniteElement<dim, spacedim> &/*fe_other*/) const
 {
   // this is a discontinuous element, so by definition there will
   // be no constraints wherever this element comes together with
index 5164662117b260c44d19cce03d33de1f9ece2ac9..27b57ae17929dcf8d3e2213b32f7434ef9579c9d 100644 (file)
@@ -363,7 +363,7 @@ template <int spacedim>
 void
 FE_FaceQ<1,spacedim>::
 get_subface_interpolation_matrix (const FiniteElement<1,spacedim> &x_source_fe,
-                                  const unsigned int        subface,
+                                  const unsigned int        /*subface*/,
                                   FullMatrix<double>       &interpolation_matrix) const
 {
   Assert (interpolation_matrix.n() == this->dofs_per_face,
@@ -412,7 +412,7 @@ FE_FaceQ<1,spacedim>::hp_constraints_are_implemented () const
 template <int spacedim>
 FiniteElementDomination::Domination
 FE_FaceQ<1,spacedim>::
-compare_for_face_domination (const FiniteElement<1,spacedim> &fe_other) const
+compare_for_face_domination (const FiniteElement<1,spacedim> &/*fe_other*/) const
 {
   return FiniteElementDomination::no_requirements;
 }
index 255a08a5c673e3bae19b38e8d77958d6ff735192..99318d886b3ee2efe9bbff7577df6eea61ca78b2 100644 (file)
@@ -86,8 +86,8 @@ namespace
 
 
   void
-  get_face_sign_change_rt (const Triangulation<3>::cell_iterator &cell,
-                           const unsigned int                      dofs_per_face,
+  get_face_sign_change_rt (const Triangulation<3>::cell_iterator &/*cell*/,
+                           const unsigned int                     /*dofs_per_face*/,
                            std::vector<double>                   &face_sign)
   {
     std::fill (face_sign.begin (), face_sign.end (), 1.0);
@@ -95,8 +95,8 @@ namespace
   }
 
   void
-  get_face_sign_change_nedelec (const Triangulation<1>::cell_iterator &,
-                                const unsigned int                     ,
+  get_face_sign_change_nedelec (const Triangulation<1>::cell_iterator &/*cell*/,
+                                const unsigned int                     /*dofs_per_face*/,
                                 std::vector<double>                   &face_sign)
   {
     // nothing to do in 1d
@@ -106,8 +106,8 @@ namespace
 
 
   void
-  get_face_sign_change_nedelec (const Triangulation<2>::cell_iterator &cell,
-                                const unsigned int                     dofs_per_face,
+  get_face_sign_change_nedelec (const Triangulation<2>::cell_iterator &/*cell*/,
+                                const unsigned int                     /*dofs_per_face*/,
                                 std::vector<double>                   &face_sign)
   {
     std::fill (face_sign.begin (), face_sign.end (), 1.0);
@@ -117,7 +117,7 @@ namespace
 
   void
   get_face_sign_change_nedelec (const Triangulation<3>::cell_iterator &cell,
-                                const unsigned int                      dofs_per_face,
+                                const unsigned int                     /*dofs_per_face*/,
                                 std::vector<double>                   &face_sign)
   {
     const unsigned int dim = 3;
index 44ab2b8f17a8e2218f8166e11ca6f3466d010152..7c1c533efaa77dd08793445e41eac62d60745c1b 100644 (file)
@@ -119,7 +119,7 @@ struct FE_Q_Base<POLY,xdim,xspacedim>::Implementation
 
   template <int spacedim>
   static
-  void initialize_constraints (const std::vector<Point<1> > &points,
+  void initialize_constraints (const std::vector<Point<1> > &/*points*/,
                                FE_Q_Base<POLY,2,spacedim> &fe)
   {
     const unsigned int dim = 2;
@@ -222,7 +222,7 @@ struct FE_Q_Base<POLY,xdim,xspacedim>::Implementation
 
   template <int spacedim>
   static
-  void initialize_constraints (const std::vector<Point<1> > &points,
+  void initialize_constraints (const std::vector<Point<1> > &/*points*/,
                                FE_Q_Base<POLY,3,spacedim> &fe)
   {
     const unsigned int dim = 3;
index 3c3730a43984439c755b994b7a853bc757075515..3a5e2ef43d5958009d4ee841fb981bae4897baf6 100644 (file)
@@ -612,8 +612,8 @@ namespace GridGenerator
   template<>
   void
   parallelogram (Triangulation<3>  &tria,
-                 const Point<3> (&corners)[3],
-                 const bool         colorize)
+                 const Point<3>   (&/*corners*/)[3],
+                 const bool         /*colorize*/)
   {
     Assert (false, ExcNotImplemented());
   }
@@ -621,8 +621,8 @@ namespace GridGenerator
   template<>
   void
   parallelogram (Triangulation<1>  &tria,
-                 const Point<1> (&corners)[1],
-                 const bool         colorize)
+                 const Point<1>   (&/*corners*/)[1],
+                 const bool         /*colorize*/)
   {
     Assert (false, ExcNotImplemented());
   }
index e709eb688377064e90d37a840ec0e9cff14f535c..ce7f07d6b751b072a61ee450cd4b25d9d0068aff 100644 (file)
@@ -1407,7 +1407,8 @@ void GridOut::write_xfig (
 
 
 template <int dim, int spacedim>
-void GridOut::write_svg(const Triangulation<dim,spacedim> &tria, std::ostream &out) const
+void GridOut::write_svg (const Triangulation<dim,spacedim> &tria,
+                         std::ostream &/*out*/) const
 {
   Assert(false, ExcNotImplemented());
 }
index 24fd7b9db2458a863dc982845d0a09d12363b52a..2dfc35e64d773c7daa6cacc59bd7138d624aa3af 100644 (file)
@@ -189,7 +189,7 @@ get_new_point_on_quad (const Triangulation<1,3>::quad_iterator &) const
 template <int dim, int spacedim>
 Point<spacedim>
 Manifold<dim, spacedim>::
-get_new_point_on_hex (const typename Triangulation<dim, spacedim>::hex_iterator &hex) const
+get_new_point_on_hex (const typename Triangulation<dim, spacedim>::hex_iterator &/*hex*/) const
 {
   Assert (false, ExcImpossibleInDim(dim));
   return Point<spacedim>();
@@ -269,7 +269,7 @@ get_new_point (const Quadrature<spacedim> &quad) const
 
 template <int dim, int spacedim>
 Point<spacedim>
-FlatManifold<dim, spacedim>::project_to_manifold (const std::vector<Point<spacedim> > &vertices,
+FlatManifold<dim, spacedim>::project_to_manifold (const std::vector<Point<spacedim> > &/*vertices*/,
                                                   const Point<spacedim> &candidate) const
 {
   return candidate;
index ae82ff13947b609a4b81f9fad17cb55afeb31c7c..27e83fa3bc55df6791b3d01d24e73fa23491d979 100644 (file)
@@ -609,7 +609,7 @@ namespace PETScWrappers
 
   void
   MatrixBase::print (std::ostream &out,
-                     const bool    alternative_output) const
+                     const bool    /*alternative_output*/) const
   {
     std::pair<MatrixBase::size_type, MatrixBase::size_type>
     loc_range = local_range();
index 27de01d877ed77107760b1d414ead9559f1cf7a0..41c7cda412537ff00dd2397c7edaa3b081a4ecf8 100644 (file)
@@ -30,10 +30,10 @@ DataPostprocessor<dim>::~DataPostprocessor()
 template <int dim>
 void
 DataPostprocessor<dim>::
-compute_derived_quantities_scalar (const std::vector<double>         &uh,
-                                   const std::vector<Tensor<1,dim> > &duh,
-                                   const std::vector<Tensor<2,dim> > &dduh,
-                                   const std::vector<Point<dim> >    &normals,
+compute_derived_quantities_scalar (const std::vector<double>         &/*uh*/,
+                                   const std::vector<Tensor<1,dim> > &/*duh*/,
+                                   const std::vector<Tensor<2,dim> > &/*dduh*/,
+                                   const std::vector<Point<dim> >    &/*normals*/,
                                    const std::vector<Point<dim> >    &/*evaluation_points*/,
                                    std::vector<Vector<double> >      &computed_quantities) const
 {
@@ -46,10 +46,10 @@ compute_derived_quantities_scalar (const std::vector<double>         &uh,
 template <int dim>
 void
 DataPostprocessor<dim>::
-compute_derived_quantities_vector (const std::vector<Vector<double> > &uh,
-                                   const std::vector<std::vector<Tensor<1,dim> > > &duh,
-                                   const std::vector<std::vector<Tensor<2,dim> > > &dduh,
-                                   const std::vector<Point<dim> >                  &normals,
+compute_derived_quantities_vector (const std::vector<Vector<double> > &/*uh*/,
+                                   const std::vector<std::vector<Tensor<1,dim> > > &/*duh*/,
+                                   const std::vector<std::vector<Tensor<2,dim> > > &/*dduh*/,
+                                   const std::vector<Point<dim> >                  &/*normals*/,
                                    const std::vector<Point<dim> >                  &/*evaluation_points*/,
                                    std::vector<Vector<double> >                    &computed_quantities) const
 {
index bbb429d07d238810081558e9a6bd1d130ef2e56b..a225524c57482e6a4b981075f62f4e25b01bef53 100644 (file)
@@ -1135,17 +1135,17 @@ namespace MatrixCreator
 
     template <>
     void
-    create_boundary_mass_matrix_1<1,3> (DoFHandler<1,3>::active_cell_iterator const &cell,
                                         MatrixCreator::internal::AssemblerBoundary::Scratch const
                                         &scratch,
+    create_boundary_mass_matrix_1<1,3> (DoFHandler<1,3>::active_cell_iterator const &/*cell*/,
                                         MatrixCreator::internal::AssemblerBoundary::CopyData<DoFHandler<1,
-                                        3> > &copy_data,
                                         Mapping<1,3> const &mapping,
                                         FiniteElement<1,3> const &fe,
                                         Quadrature<0> const &q,
-                                        FunctionMap<3>::type const &boundary_functions,
-                                        Function<3> const *const coefficient,
-                                        std::vector<unsigned int> const &component_mapping)
+                                        3> > &/*copy_data*/,
+                                        FunctionMap<3>::type const &/*boundary_functions*/,
+                                        Function<3> const *const /*coefficient*/,
+                                        std::vector<unsigned int> const &/*component_mapping*/)
     {
       Assert(false,ExcNotImplemented());
     }
index 9b3e93c86c0723d9cd671c42eb89f9037c64a0ed..1d0d88710b0d620274d4d4ce311f7434cf5857ba 100644 (file)
@@ -298,7 +298,7 @@ namespace OpenCASCADE
                                const double c_y,
                                const double c_z,
                                const double c,
-                               const double tolerance)
+                               const double /*tolerance*/)
   {
     Handle(Geom_Plane) plane = new Geom_Plane(c_x,c_y,c_z,c);
     BRepAlgo_Section section(in_shape, plane);
@@ -590,7 +590,7 @@ namespace OpenCASCADE
   push_forward_and_differential_forms(const TopoDS_Face &face,
                                       const double u,
                                       const double v,
-                                      const double tolerance)
+                                      const double /*tolerance*/)
   {
     Handle(Geom_Surface) SurfToProj = BRep_Tool::Surface(face);
     GeomLProp_SLProps props(SurfToProj, u, v, 1, 1e-7);

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.