MGLevelObject<Vector<number> >& dst,
const InVector& src) const
{
-
// Make src a real finite element function
// InVector src = osrc;
// constraints->distribute(src);
// on all levels to zero
unsigned int minlevel = dst.get_minlevel();
unsigned int maxlevel = dst.get_maxlevel();
-
+
dst.clear();
+ Assert(sizes.size()==mg_dof_handler.get_tria().n_levels(),
+ ExcMatricesNotBuilt());
for (unsigned int l=minlevel;l<=maxlevel;++l)
dst[l].reinit(sizes[l]);
dst.clear();
+ Assert(sizes.size()==mg_dof_handler.get_tria().n_levels(),
+ ExcMatricesNotBuilt());
for (unsigned int l=minlevel;l<=maxlevel;++l)
dst[l].reinit(sizes[l][selected]);
*/
DeclException0(ExcNoProlongation);
+ /**
+ * Call @p{build_matrices}
+ * function first.
+ */
+ DeclException0(ExcMatricesNotBuilt);
+
private:
/**
*/
std::vector<std::vector<unsigned int> > mg_component_start;
+ /**
+ * Call @p{build_matrices}
+ * function first.
+ */
+ DeclException0(ExcMatricesNotBuilt);
+
private:
std::vector<BlockSparsityPattern> prolongation_sparsities;