From: David Wells Date: Sat, 1 Aug 2015 00:30:15 +0000 (-0400) Subject: Remove commented out code in headers. X-Git-Tag: v8.4.0-rc2~681^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=51557f5ef68593912046d5f836087750bbd6febe;p=dealii.git Remove commented out code in headers. 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. --- diff --git a/include/deal.II/grid/tria_iterator.templates.h b/include/deal.II/grid/tria_iterator.templates.h index 9b6d800272..c736fc4a33 100644 --- a/include/deal.II/grid/tria_iterator.templates.h +++ b/include/deal.II/grid/tria_iterator.templates.h @@ -85,38 +85,6 @@ TriaRawIterator::operator = (const TriaRawIterator &i) } -// template -// template -// inline -// TriaRawIterator & -// TriaRawIterator::operator = (const TriaRawIterator &i) -// { -// accessor.copy_from (i.accessor); -// return *this; -// } - - -// template -// template -// inline -// TriaRawIterator & -// TriaRawIterator::operator = (const TriaIterator &i) -// { -// accessor.copy_from (i.accessor); -// return *this; -// } - - -// template -// template -// inline -// TriaRawIterator & -// TriaRawIterator::operator = (const TriaActiveIterator &i) -// { -// accessor.copy_from (i.accessor); -// return *this; -// } - template inline diff --git a/include/deal.II/lac/block_sparse_matrix_ez.templates.h b/include/deal.II/lac/block_sparse_matrix_ez.templates.h index 34d7e3cc36..1ce5c06cfe 100644 --- a/include/deal.II/lac/block_sparse_matrix_ez.templates.h +++ b/include/deal.II/lac/block_sparse_matrix_ez.templates.h @@ -178,42 +178,6 @@ BlockSparseMatrixEZ::collect_sizes () -// template -// unsigned int -// BlockSparseMatrixEZ::n_nonzero_elements () const -// { -// return sparsity_pattern->n_nonzero_elements (); -// }; - - - -// template -// unsigned int -// BlockSparseMatrixEZ::n_actually_nonzero_elements () const -// { -// unsigned int count = 0; -// for (unsigned int i=0; in_actually_nonzero_elements (); -// return count; -// }; - - - -// template -// std::size_t -// BlockSparseMatrixEZ::memory_consumption () const -// { -// std::size_t mem = sizeof(*this); -// mem += MemoryConsumption::memory_consumption (sub_objects); -// for (unsigned int r=0; r::fill_permutation (const FullMatrix &src, -/* template */ -/* template */ -/* void FullMatrix::fill (const number2* entries) */ -/* { */ -/* if (n_cols()*n_rows() != 0) */ -/* std::copy (entries, entries+n_rows()*n_cols(), &this->values[0]); */ -/* } */ - - - template void FullMatrix::add_row (const size_type i, const number s, diff --git a/include/deal.II/lac/precondition_block.templates.h b/include/deal.II/lac/precondition_block.templates.h index 9612a061ad..e25f2ce2d7 100644 --- a/include/deal.II/lac/precondition_block.templates.h +++ b/include/deal.II/lac/precondition_block.templates.h @@ -240,11 +240,6 @@ void PreconditionBlock::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 b_cell(this->blocksize), x_cell(this->blocksize); // cell_row, cell_column are the diff --git a/include/deal.II/lac/sparse_matrix_ez.templates.h b/include/deal.II/lac/sparse_matrix_ez.templates.h index 75f472bef2..dc64139d0b 100644 --- a/include/deal.II/lac/sparse_matrix_ez.templates.h +++ b/include/deal.II/lac/sparse_matrix_ez.templates.h @@ -546,32 +546,12 @@ SparseMatrixEZ::block_write (std::ostream &out) const out.write(reinterpret_cast(&*r), sizeof(RowInfo) * row_info.size()); -// Just in case that vector entries are not stored consecutively -// const typename std::vector::const_iterator re = row_info.end(); - -// while (r != re) -// { -// out.write(reinterpret_cast(&*r), -// sizeof(RowInfo)); -// ++r; -// } - out << "]["; typename std::vector::const_iterator d = data.begin(); out.write(reinterpret_cast(&*d), sizeof(Entry) * data.size()); -// Just in case that vector entries are not stored consecutively -// const typename std::vector::const_iterator de = data.end(); - -// while (d != de) -// { -// out.write(reinterpret_cast(&*d), -// sizeof(Entry)); -// ++d; -// } - out << ']'; AssertThrow (out, ExcIO()); diff --git a/include/deal.II/meshworker/integration_info.templates.h b/include/deal.II/meshworker/integration_info.templates.h index f0ee81fb45..10577a243b 100644 --- a/include/deal.II/meshworker/integration_info.templates.h +++ b/include/deal.II/meshworker/integration_info.templates.h @@ -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; in_gradients()); // For all selected finite @@ -234,4 +229,3 @@ namespace MeshWorker DEAL_II_NAMESPACE_CLOSE - diff --git a/include/deal.II/multigrid/mg_block_smoother.h b/include/deal.II/multigrid/mg_block_smoother.h index 590b968bfa..ea3bed848d 100644 --- a/include/deal.II/multigrid/mg_block_smoother.h +++ b/include/deal.II/multigrid/mg_block_smoother.h @@ -283,26 +283,21 @@ MGSmootherBlock::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; isadd(-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; diff --git a/include/deal.II/multigrid/mg_smoother.h b/include/deal.II/multigrid/mg_smoother.h index 45160691d6..b0b7dd8c34 100644 --- a/include/deal.II/multigrid/mg_smoother.h +++ b/include/deal.II/multigrid/mg_smoother.h @@ -213,16 +213,6 @@ namespace mg template void initialize (const MGLevelObject &matrices, const MGLevelObject &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 -// void initialize (const MGLevelObject >& matrices, -// const typename RELAX::AdditionalData & additional_data = typename RELAX::AdditionalData()); /** * Empty all vectors. diff --git a/include/deal.II/multigrid/mg_transfer_component.templates.h b/include/deal.II/multigrid/mg_transfer_component.templates.h index 292a71d0ad..bbe7d2b617 100644 --- a/include/deal.II/multigrid/mg_transfer_component.templates.h +++ b/include/deal.II/multigrid/mg_transfer_component.templates.h @@ -151,12 +151,6 @@ MGTransferSelect::do_copy_from_mg ( OutVector &dst, const MGLevelObject > &src) const { -// const FiniteElement& fe = mg_dof_handler.get_fe(); - -// const unsigned int dofs_per_cell = fe.dofs_per_cell; -// std::vector global_dof_indices (dofs_per_cell); -// std::vector level_dof_indices (dofs_per_cell); - typename DoFHandler::active_cell_iterator level_cell = mg_dof_handler.begin_active(); const typename DoFHandler::active_cell_iterator diff --git a/include/deal.II/numerics/matrix_tools.h b/include/deal.II/numerics/matrix_tools.h index 852e06b6f0..b2f29225ac 100644 --- a/include/deal.II/numerics/matrix_tools.h +++ b/include/deal.II/numerics/matrix_tools.h @@ -370,29 +370,6 @@ namespace MatrixCreator const Function *const weight = 0, std::vector component_mapping = std::vector()); -// * 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 &matrix, -// const FunctionMap<1>::type &boundary_functions, -// Vector &rhs_vector, -// std::vector&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 &matrix, -// const FunctionMap<2>::type &boundary_functions, -// Vector &rhs_vector, -// std::vector&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 *const a = 0, std::vector component_mapping = std::vector()); - /** - * 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 &matrix, -// const FunctionMap<1>::type &boundary_functions, -// Vector &rhs_vector, -// std::vector&dof_to_boundary_mapping, -// const Function<1> * const a = 0); - /** * Same function as above, but for hp objects. */ diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index 746d8525df..18aa3d2ed7 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -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]; }