for (; h != endh; ++h, ++l)
{
// @whattodo Some of the problems in petsc_vector_base.h are instantiated here.
- /* h->get_dof_values(data_1, cell_data_1); // <- complaint line 655 */
+ /* h->get_dof_values(data_1, cell_data_1); // <- complaint line 655 */
Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
transfer.vmult(cell_data_2, cell_data_1);
// if we work on parallel distributed
// vectors, we have to ensure, that we only
// work on dofs this processor owns.
- IndexSet locally_owned_dofs = dof2.locally_owned_dofs();
+ IndexSet locally_owned_dofs = dof2.locally_owned_dofs();
// when a discontinuous element is
// interpolated to a continuous
for (types::global_dof_index i=0; i<dof2.n_dofs(); ++i)
if (locally_owned_dofs.is_element(i))
{
- // @whattodo
- // Assert(touch_count(i)!=0, ExcInternalError());
+ // @whattodo Workaround: Add a function is_zero like is_finite?
+ // Assert(touch_count(i)!=0, ExcInternalError());
Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
u2(i) /= touch_count(i);
}
// finish the work on parallel vectors
u2.compress(VectorOperation::insert);
+
// Apply hanging node constraints.
constraints.distribute(u2);
}
// to get the array of values from PETSc
// in every iteration), but works
PetscScalar m = 0;
- // @whattodo
+ // @whattodo How do we get the maximum element of a complex vector? This only makes sense in real.
// for (unsigned int i=0; i<criteria.size(); ++i)
// m = std::max (m, criteria(i));
Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
// to get the array of values from PETSc
// in every iteration), but works
PetscScalar m = criteria(0);
- // @whattodo
+ // @whattodo How do we get the minimum element of a complex vector? This only makes sense in real.
// for (unsigned int i=1; i<criteria.size(); ++i)
// m = std::min (m, criteria(i));
Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
// find such an entry, take one
// @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)
// to check vector_name is in the map.
typename std::map <std::string, std::vector <std::vector <double> > >::iterator data_store_field = data_store.find(vector_name);
Assert (data_store_field != data_store.end(), ExcMessage("vector_name not in class"));
+
// Repeat for component_mask
typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(vector_name);
Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
if (mask->second[comp])
{
unsigned int solution_index = point->solution_indices[comp];
- //@whattodo
+ //@whattodo data_store_field shoud be typename VECTOR::value_type, but that cuase problems elsewhere...
(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));
+
+ // 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++;