]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove commented out code in headers. 1255/head
authorDavid Wells <drwells@vt.edu>
Sat, 1 Aug 2015 00:30:15 +0000 (20:30 -0400)
committerDavid Wells <drwells@vt.edu>
Tue, 4 Aug 2015 20:08:02 +0000 (16:08 -0400)
The code in tria_iterator.templates.h was commented out in 2010.

The code in block_sparse_matrix_ez.templates.h was commented out when it
appeared in 2002.

The code in full_matrix.templates.h was commented out in 2001.

The code in precondition_block.templates.h was commented out in 2011.

The code in sparse_matrix_ez.templates.h was commented out in 2003.

The code in mg_block_smoother.h was commented out in 2005.

The code in mg_smoother.h was commented out in 2010.

The code in mg_transfer_component.templates.h was commented out in 2010.

The code in integration_info.templates.h was commented out in 2011.

The code in matrix_tools.h was commented out at some point prior to 2012.

The code in vector_tools.templates.h was commented out at some point prior to 2012.

include/deal.II/grid/tria_iterator.templates.h
include/deal.II/lac/block_sparse_matrix_ez.templates.h
include/deal.II/lac/full_matrix.templates.h
include/deal.II/lac/precondition_block.templates.h
include/deal.II/lac/sparse_matrix_ez.templates.h
include/deal.II/meshworker/integration_info.templates.h
include/deal.II/multigrid/mg_block_smoother.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/multigrid/mg_transfer_component.templates.h
include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/vector_tools.templates.h

index 9b6d8002727c790e4ea68e056eedf9efd3d67cf0..c736fc4a336e943c36c88ac6d49c9bd1324a489e 100644 (file)
@@ -85,38 +85,6 @@ TriaRawIterator<Accessor>::operator = (const TriaRawIterator<Accessor> &i)
 }
 
 
-// template <typename Accessor>
-// template <typename OtherAccessor>
-// inline
-// TriaRawIterator<Accessor> &
-// TriaRawIterator<Accessor>::operator = (const TriaRawIterator<OtherAccessor> &i)
-// {
-//   accessor.copy_from (i.accessor);
-//   return *this;
-// }
-
-
-// template <typename Accessor>
-// template <typename OtherAccessor>
-// inline
-// TriaRawIterator<Accessor> &
-// TriaRawIterator<Accessor>::operator = (const TriaIterator<OtherAccessor> &i)
-// {
-//   accessor.copy_from (i.accessor);
-//   return *this;
-// }
-
-
-// template <typename Accessor>
-// template <typename OtherAccessor>
-// inline
-// TriaRawIterator<Accessor> &
-// TriaRawIterator<Accessor>::operator = (const TriaActiveIterator<OtherAccessor> &i)
-// {
-//   accessor.copy_from (i.accessor);
-//   return *this;
-// }
-
 
 template <typename Accessor>
 inline
index 34d7e3cc36dc01a7066d9840e32cae03680ed5e8..1ce5c06cfe4e0aed1a8a6c2d9da1cde47153cba0 100644 (file)
@@ -178,42 +178,6 @@ BlockSparseMatrixEZ<number>::collect_sizes ()
 
 
 
-//  template <typename number>
-//  unsigned int
-//  BlockSparseMatrixEZ<number>::n_nonzero_elements () const
-//  {
-//    return sparsity_pattern->n_nonzero_elements ();
-//  };
-
-
-
-//  template <typename number>
-//  unsigned int
-//  BlockSparseMatrixEZ<number>::n_actually_nonzero_elements () const
-//  {
-//    unsigned int count = 0;
-//    for (unsigned int i=0; i<rows; ++i)
-//      for (unsigned int j=0; j<columns; ++j)
-//        count += sub_objects[i][j]->n_actually_nonzero_elements ();
-//    return count;
-//  };
-
-
-
-//  template <typename number>
-//  std::size_t
-//  BlockSparseMatrixEZ<number>::memory_consumption () const
-//  {
-//    std::size_t mem = sizeof(*this);
-//    mem += MemoryConsumption::memory_consumption (sub_objects);
-//    for (unsigned int r=0; r<rows; ++r)
-//      for (unsigned int c=0; c<columns; ++c)
-//        mem += MemoryConsumption::memory_consumption(*sub_objects[r][c]);
-//    return mem;
-//  };
-
-
-
 DEAL_II_NAMESPACE_CLOSE
 
 #endif // ifdef block_sparse_matrix_templates_h
index 80abb76e5306a6e8e21ed034e28704ba5d92a6a1..3e0602e55cf90bc3c5393dff448030501143c113 100644 (file)
@@ -376,16 +376,6 @@ void FullMatrix<number>::fill_permutation (const FullMatrix<number2> &src,
 
 
 
-/*  template <typename number> */
-/*  template <typename number2> */
-/*  void FullMatrix<number>::fill (const number2* entries) */
-/*  { */
-/*      if (n_cols()*n_rows() != 0) */
-/*        std::copy (entries, entries+n_rows()*n_cols(), &this->values[0]); */
-/*  } */
-
-
-
 template <typename number>
 void FullMatrix<number>::add_row (const size_type i,
                                   const number s,
index 9612a061ad9dc1a9d9ac9cc25501ee32ddee2c9e..e25f2ce2d7aea54c9f8ddc7a73573abc37225bbb 100644 (file)
@@ -240,11 +240,6 @@ void PreconditionBlock<MATRIX,inverse_type>::forward_step (
   const bool permuted = (permutation.size() == M.m());
   const bool cell_permuted = (permutation.size() == this->size());
 
-//   deallog << "Permutation " << permutation.size();
-//   if (permuted) deallog << " point";
-//   if (cell_permuted) deallog << " block";
-//   deallog << std::endl;
-
   Vector<number2> b_cell(this->blocksize), x_cell(this->blocksize);
 
   // cell_row, cell_column are the
index 75f472bef2abe97cef67eb186dc6fe5640ea9b87..dc64139d0b93898849f8ff8b9b39b3382e667ca8 100644 (file)
@@ -546,32 +546,12 @@ SparseMatrixEZ<number>::block_write (std::ostream &out) const
   out.write(reinterpret_cast<const char *>(&*r),
             sizeof(RowInfo) * row_info.size());
 
-//   Just in case that vector entries are not stored consecutively
-//   const typename std::vector<RowInfo>::const_iterator re = row_info.end();
-
-//   while (r != re)
-//     {
-//       out.write(reinterpret_cast<const char*>(&*r),
-//              sizeof(RowInfo));
-//       ++r;
-//     }
-
   out << "][";
 
   typename std::vector<Entry>::const_iterator d = data.begin();
   out.write(reinterpret_cast<const char *>(&*d),
             sizeof(Entry) * data.size());
 
-//   Just in case that vector entries are not stored consecutively
-//   const typename std::vector<Entry>::const_iterator de = data.end();
-
-//   while (d != de)
-//     {
-//       out.write(reinterpret_cast<const char*>(&*d),
-//              sizeof(Entry));
-//       ++d;
-//     }
-
   out << ']';
 
   AssertThrow (out, ExcIO());
index f0ee81fb45d4b20921407dfad444cbf7b1937f8f..10577a243bd4e31622d7b747fd83ed0295c0f7e6 100644 (file)
@@ -31,22 +31,17 @@ namespace MeshWorker
     const unsigned int nqp = fevalv[0]->n_quadrature_points;
 
     values.resize(global_data->n_values());
-//    deallog << "values: " << values.size() << " [";
     // For all selected finite
     // element functions
     for (unsigned int i=0; i<values.size(); ++i)
       {
         values[i].resize(n_components);
-//      deallog << ' ' << values[i].size() << " {";
         // For all components
         for (unsigned int j=0; j<values[i].size(); ++j)
           {
             values[i][j].resize(nqp);
-//          deallog << ' ' << values[i][j].size();
           }
-//      deallog << " }";
       }
-//    deallog << " ]" << std::endl;
 
     gradients.resize(global_data->n_gradients());
     // For all selected finite
@@ -234,4 +229,3 @@ namespace MeshWorker
 
 
 DEAL_II_NAMESPACE_CLOSE
-
index 590b968bfa30451a3a266982be00f4274b8103cf..ea3bed848d4b6040b15727765bfa9a1a0176a3cd 100644 (file)
@@ -283,26 +283,21 @@ MGSmootherBlock<MATRIX, RELAX, number>::smooth(
   bool T = transpose;
   if (symmetric && (steps2 % 2 == 0))
     T = false;
-//  cerr << 'S' << level;
-//  cerr << '(' << matrices[level]->m() << ',' << matrices[level]->n() << ')';
 
   for (unsigned int i=0; i<steps2; ++i)
     {
       if (T)
         {
-//        cerr << 'T';
           matrices[level].vmult(*r,u);
           r->sadd(-1.,1.,rhs);
           smoothers[level].Tvmult(*d, *r);
         }
       else
         {
-//        cerr << 'N';
           matrices[level].vmult(*r,u);
           r->sadd(-1.,1.,rhs);
           smoothers[level].vmult(*d, *r);
         }
-//      cerr << '{' << r->l2_norm() << '}';
       u += *d;
       if (symmetric)
         T = !T;
index 45160691d691f7e4ff8614887bc10b3b2c29efae..b0b7dd8c34e0a694a2ade7eb62ba727d52741c54 100644 (file)
@@ -213,16 +213,6 @@ namespace mg
     template <class MATRIX2, class DATA>
     void initialize (const MGLevelObject<MATRIX2> &matrices,
                      const MGLevelObject<DATA> &additional_data);
-    /**
-     * Initialize for matrix blocks. This function initializes the smoothing
-     * operator with the same smoother for each level.
-     *
-     * @p additional_data is an object of type @p RELAX::AdditionalData and is
-     * handed to the initialization function of the relaxation method.
-     */
-//     template <class MATRIX2>
-//     void initialize (const MGLevelObject<MatrixBlock<MATRIX2> >& matrices,
-//                   const typename RELAX::AdditionalData & additional_data = typename RELAX::AdditionalData());
 
     /**
      * Empty all vectors.
index 292a71d0ad9766a193cf4c18fa7b8ccd02951773..bbe7d2b6178a9cdda63768561079e59873e84d90 100644 (file)
@@ -151,12 +151,6 @@ MGTransferSelect<number>::do_copy_from_mg (
   OutVector                            &dst,
   const MGLevelObject<Vector<number> > &src) const
 {
-//  const FiniteElement<dim>& fe = mg_dof_handler.get_fe();
-
-//  const unsigned int dofs_per_cell = fe.dofs_per_cell;
-//  std::vector<unsigned int> global_dof_indices (dofs_per_cell);
-//  std::vector<unsigned int> level_dof_indices (dofs_per_cell);
-
   typename DoFHandler<dim,spacedim>::active_cell_iterator
   level_cell = mg_dof_handler.begin_active();
   const typename DoFHandler<dim,spacedim>::active_cell_iterator
index 852e06b6f08088b1dc40b183265bd7ac333e3b18..b2f29225acdc6ca78350723b976c0e6a6b2a7b63 100644 (file)
@@ -370,29 +370,6 @@ namespace MatrixCreator
                                     const Function<spacedim> *const weight = 0,
                                     std::vector<unsigned int> component_mapping = std::vector<unsigned int>());
 
-//                                    * Same function, but for 1d.
-//                                    */
-//
-//     void create_boundary_mass_matrix (const Mapping<1,1>       &mapping,
-//                                    const DoFHandler<1,1>    &dof,
-//                                    const Quadrature<0>    &q,
-//                                    SparseMatrix<double>   &matrix,
-//                                    const FunctionMap<1>::type &boundary_functions,
-//                                    Vector<double>         &rhs_vector,
-//                                    std::vector<types::global_dof_index>&dof_to_boundary_mapping,
-//                                    const Function<1> * const a = 0);
-// //codimension 1
-//
-//     void create_boundary_mass_matrix (const Mapping<1,2>       &mapping,
-//                                    const DoFHandler<1,2>    &dof,
-//                                    const Quadrature<0>    &q,
-//                                    SparseMatrix<double>   &matrix,
-//                                    const FunctionMap<2>::type &boundary_functions,
-//                                    Vector<double>         &rhs_vector,
-//                                    std::vector<types::global_dof_index>&dof_to_boundary_mapping,
-//                                    const Function<2> * const a = 0);
-
-
 
   /**
    * Calls the create_boundary_mass_matrix() function, see above, with
@@ -422,19 +399,6 @@ namespace MatrixCreator
                                     const Function<spacedim> *const a = 0,
                                     std::vector<unsigned int> component_mapping = std::vector<unsigned int>());
 
-  /**
-   * Same function as above, but for hp objects.
-   */
-//
-//     void create_boundary_mass_matrix (const hp::MappingCollection<1,1>       &mapping,
-//                                    const hp::DoFHandler<1,1>    &dof,
-//                                    const hp::QCollection<0>    &q,
-//                                    SparseMatrix<double>   &matrix,
-//                                    const FunctionMap<1>::type &boundary_functions,
-//                                    Vector<double>         &rhs_vector,
-//                                    std::vector<types::global_dof_index>&dof_to_boundary_mapping,
-//                                    const Function<1> * const a = 0);
-
   /**
    * Same function as above, but for hp objects.
    */
index 746d8525dff754af86f03a72db238d05644c3911..18aa3d2ed76231b56ce3daa714615fa3cbd6bc4a 100644 (file)
@@ -162,9 +162,7 @@ namespace VectorTools
 
             if (representative)
               {
-                // rep_index=dofs_of_rep_points.size()
                 dof_to_rep_index_table[fe_index].push_back(dofs_of_rep_points[fe_index].size());
-                // dofs_of_rep_points[rep_index]=i
                 dofs_of_rep_points[fe_index].push_back(i);
                 ++n_rep_points[fe_index];
               }

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.