From c6f04ef342afead9c9c75e196ea48022d976d0f4 Mon Sep 17 00:00:00 2001 From: young Date: Sat, 5 Oct 2013 03:45:53 +0000 Subject: [PATCH] Restore branch to a compilable state. No masks, no hidden compiler warnings. git-svn-id: https://svn.dealii.org/branches/branch_petscscalar_complex@31138 0785d39b-7218-0410-832d-ea1e28bc413d --- .../deal.II/algorithms/operator.templates.h | 12 +++++++----- .../include/deal.II/lac/block_vector_base.h | 19 ++++++++++++------- .../deal.II/lac/constraint_matrix.templates.h | 19 ++++++++++++++++--- .../include/deal.II/lac/petsc_vector_base.h | 14 ++++++++++---- .../deal.II/numerics/vector_tools.templates.h | 4 +++- deal.II/source/fe/fe_tools_interpolate.cc | 4 +++- deal.II/source/fe/fe_values.cc | 3 ++- deal.II/source/grid/grid_refinement.cc | 12 ++++++++---- deal.II/source/numerics/data_out_dof_data.cc | 4 +++- deal.II/source/numerics/matrix_tools.cc | 19 ++++++++++++------- .../source/numerics/point_value_history.cc | 7 ++++++- 11 files changed, 82 insertions(+), 35 deletions(-) diff --git a/deal.II/include/deal.II/algorithms/operator.templates.h b/deal.II/include/deal.II/algorithms/operator.templates.h index 173d10b9b7..307466f5f7 100644 --- a/deal.II/include/deal.II/algorithms/operator.templates.h +++ b/deal.II/include/deal.II/algorithms/operator.templates.h @@ -72,11 +72,13 @@ namespace Algorithms } else { - (*os) << ' ' << step; - for (unsigned int i=0; isize(); ++j) - (*os) << ' ' << (*vectors(i))(j); - (*os) << std::endl; + /* @whattodo */ + /* (*os) << ' ' << step; */ + /* for (unsigned int i=0; isize(); ++j) */ + /* (*os) << ' ' << (*vectors(i))(j); */ + /* (*os) << std::endl; */ + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); } return *this; } diff --git a/deal.II/include/deal.II/lac/block_vector_base.h b/deal.II/include/deal.II/lac/block_vector_base.h index 8991123408..bad6b91390 100644 --- a/deal.II/include/deal.II/lac/block_vector_base.h +++ b/deal.II/include/deal.II/lac/block_vector_base.h @@ -2046,10 +2046,13 @@ typename BlockVectorBase::value_type BlockVectorBase::mean_value () const { value_type sum = 0.; - for (size_type i=0; i::extract_subvector_to (ForwardIterator const ForwardIterator indices_end, OutputIterator values_begin) const { - while (indices_begin != indices_end) { - *values_begin = operator()(*indices_begin); - indices_begin++; values_begin++; - } + /* @whattodo */ + /* while (indices_begin != indices_end) { */ + /* *values_begin = operator()(*indices_begin); */ + /* indices_begin++; values_begin++; */ + /* } */ + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); } #endif // DOXYGEN diff --git a/deal.II/include/deal.II/lac/constraint_matrix.templates.h b/deal.II/include/deal.II/lac/constraint_matrix.templates.h index 4a1ce1888c..28cc4d4a59 100644 --- a/deal.II/include/deal.II/lac/constraint_matrix.templates.h +++ b/deal.II/include/deal.II/lac/constraint_matrix.templates.h @@ -861,7 +861,12 @@ distribute_local_to_global (const Vector &local_vector, const size_type n_local_dofs = local_vector.size(); if (lines.empty()) - global_vector.add(local_dof_indices, local_vector); + { + /* @whattodo Note: the Vector and FullMatrix coming in should be + complex */ + /* global_vector.add(local_dof_indices, local_vector); */ + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); + } else for (size_type i=0; i 0) - global_matrix.add(row, n_values, &cols[0], &vals[0], false, true); + { + /* @whattodo Note, this is a tricky one! */ + /* global_matrix.add(row, n_values, &cols[0], &vals[0], false, true); */ + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); + } } } diff --git a/deal.II/include/deal.II/lac/petsc_vector_base.h b/deal.II/include/deal.II/lac/petsc_vector_base.h index 709e1e6185..daff61845a 100644 --- a/deal.II/include/deal.II/lac/petsc_vector_base.h +++ b/deal.II/include/deal.II/lac/petsc_vector_base.h @@ -1307,7 +1307,9 @@ namespace PETScWrappers && index(end) ) { //local entry - *(values_begin+i) = *(ptr+index-begin); + /* @whattodo Note: OutputIterator needs to be instantiated as PetscScalar (or std::complex) */ + /* *(values_begin+i) = *(ptr+index-begin); */ + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); } else { @@ -1316,7 +1318,9 @@ namespace PETScWrappers = ghost_indices.index_within_set(index); Assert(ghostidx+end-begin<(unsigned int)lsize, ExcInternalError()); - *(values_begin+i) = *(ptr+ghostidx+end-begin); + /* @whattodo Note: OutputIterator needs to be instantiated as PetscScalar (or std::complex) */ + /* *(values_begin+i) = *(ptr+ghostidx+end-begin); */ + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); } } @@ -1347,8 +1351,10 @@ namespace PETScWrappers Assert(index>=static_cast(begin) && index(end), ExcInternalError()); - - *(values_begin+i) = *(ptr+index-begin); + + /* @whattodo Note: OutputIterator needs to be instantiated as PetscScalar (or std::complex) */ + /* *(values_begin+i) = *(ptr+index-begin); */ + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); } ierr = VecRestoreArray(vector, &ptr); diff --git a/deal.II/include/deal.II/numerics/vector_tools.templates.h b/deal.II/include/deal.II/numerics/vector_tools.templates.h index 92670d6ac5..17f54d300b 100644 --- a/deal.II/include/deal.II/numerics/vector_tools.templates.h +++ b/deal.II/include/deal.II/numerics/vector_tools.templates.h @@ -5594,7 +5594,9 @@ namespace VectorTools for (unsigned int i=0; i if (mask->second[comp]) { unsigned int solution_index = point->solution_indices[comp]; - data_store_field->second[data_store_index * n_stored + store_index].push_back (solution (solution_index)); + //@whattodo + (void) solution_index; // stop g++ complaining: eventually remove this + (void) n_stored; // stop g++ complaining: eventually remove this + // data_store_field->second[data_store_index * n_stored + store_index].push_back (solution (solution_index)); + Assert ((false), ExcMessage ("This function is corrupt: @whattodo")); + store_index++; } } -- 2.39.5