}
else
{
- (*os) << ' ' << step;
- for (unsigned int i=0; i<vectors.size(); ++i)
- for (unsigned int j=0; j<vectors(i)->size(); ++j)
- (*os) << ' ' << (*vectors(i))(j);
- (*os) << std::endl;
+ /* @whattodo */
+ /* (*os) << ' ' << step; */
+ /* for (unsigned int i=0; i<vectors.size(); ++i) */
+ /* for (unsigned int j=0; j<vectors(i)->size(); ++j) */
+ /* (*os) << ' ' << (*vectors(i))(j); */
+ /* (*os) << std::endl; */
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
}
return *this;
}
BlockVectorBase<VectorType>::mean_value () const
{
value_type sum = 0.;
- for (size_type i=0; i<n_blocks(); ++i)
- sum += components[i].mean_value() * components[i].size();
- return sum/size();
+ /* @whattodo */
+ /* for (size_type i=0; i<n_blocks(); ++i) */
+ /* sum += components[i].mean_value() * components[i].size(); */
+ /* return sum/size(); */
+
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
}
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
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<n_local_dofs; ++i)
{
// inhomogeneity, we set those to:
// inhomogeneity(i)*global_matrix (i,i).
if (use_inhomogeneities_for_rhs == true)
- global_vector(global_row) += constraints.get_inhomogeneity(global_row) * new_diagonal;
+ {
+ /* @whattodo */
+ /* global_vector(global_row) += constraints.get_inhomogeneity(global_row) * new_diagonal; */
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
+ }
}
}
}
Assert (n_values == (size_type)(val_ptr - &vals[0]),
ExcInternalError());
if (n_values > 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"));
+ }
}
}
&& index<static_cast<unsigned int>(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
{
= 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"));
}
}
Assert(index>=static_cast<unsigned int>(begin)
&& index<static_cast<unsigned int>(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);
for (unsigned int i=0; i<n; ++i)
if (p_select[i])
{
- s += v(i);
+ /* @whattodo */
+ /* s += v(i); */
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
++counter;
}
// Error out if we have not constrained anything. Note that in this
for (types::global_dof_index i=0; i<dof2.n_dofs(); ++i)
if (locally_owned_dofs.is_element(i))
{
- Assert(touch_count(i)!=0, ExcInternalError());
+ // @whattodo
+ // Assert(touch_count(i)!=0, ExcInternalError());
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
u2(i) /= touch_count(i);
}
get_vector_element (const VectorType &vector,
const types::global_dof_index cell_number)
{
- return vector[cell_number];
+ // @whattodo Note, see another identical whattodo
+ // return vector[cell_number];
}
// to get the array of values from PETSc
// in every iteration), but works
PetscScalar m = 0;
- for (unsigned int i=0; i<criteria.size(); ++i)
- m = std::max (m, criteria(i));
+ // @whattodo
+ // for (unsigned int i=0; i<criteria.size(); ++i)
+ // m = std::max (m, criteria(i));
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
return m;
}
// to get the array of values from PETSc
// in every iteration), but works
PetscScalar m = criteria(0);
- for (unsigned int i=1; i<criteria.size(); ++i)
- m = std::min (m, criteria(i));
+ // @whattodo
+ // for (unsigned int i=1; i<criteria.size(); ++i)
+ // m = std::min (m, criteria(i));
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
return m;
}
#endif
get_vector_element (const VectorType &vector,
const unsigned int cell_number)
{
- return vector[cell_number];
+ // @whattodo Note, there should be a way to get the value type from a VectorType
+ // return vector[cell_number];
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
}
// entry from within the part of the
// matrix that we can see. if we can't
// find such an entry, take one
- PetscScalar average_nonzero_diagonal_entry = 1;
- for (types::global_dof_index i=local_range.first; i<local_range.second; ++i)
- if (matrix.diag_element(i) != 0)
- {
- average_nonzero_diagonal_entry = std::fabs(matrix.diag_element(i));
- break;
- }
+
+ // @whattodo Note: this is a real mess.
+ // Toby: see old notes from Diabelka
+ PetscScalar average_nonzero_diagonal_entry;
+ // PetscScalar average_nonzero_diagonal_entry = 1;
+ // for (types::global_dof_index i=local_range.first; i<local_range.second; ++i)
+ // if (matrix.diag_element(i) != 0)
+ // {
+ // average_nonzero_diagonal_entry = std::fabs(matrix.diag_element(i));
+ // break;
+ // }
+ Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
// figure out which rows of the matrix we
// have to eliminate on this processor
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++;
}
}