}
-template void BlockInfo::initialize(const DoFHandler<deal_II_dimension,deal_II_dimension>&);
-template void BlockInfo::initialize(const MGDoFHandler<deal_II_dimension,deal_II_dimension>&, bool);
-template void BlockInfo::initialize_local(const DoFHandler<deal_II_dimension,deal_II_dimension>&);
-
-#if deal_II_dimension==1 || deal_II_dimension==2
-template void BlockInfo::initialize(const DoFHandler<deal_II_dimension,deal_II_dimension+1>&);
-template void BlockInfo::initialize(const MGDoFHandler<deal_II_dimension,deal_II_dimension+1>&, bool);
-template void BlockInfo::initialize_local(const DoFHandler<deal_II_dimension,deal_II_dimension+1>&);
-#endif
-
+// explicit instantiations
+#include "block_info.inst"
DEAL_II_NAMESPACE_CLOSE
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2009, 2010 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+
+for (deal_II_dimension : DIMENSIONS)
+ {
+ template void BlockInfo::initialize(const DoFHandler<deal_II_dimension,deal_II_dimension>&);
+ template void BlockInfo::initialize(const MGDoFHandler<deal_II_dimension,deal_II_dimension>&, bool);
+ template void BlockInfo::initialize_local(const DoFHandler<deal_II_dimension,deal_II_dimension>&);
+
+#if deal_II_dimension < 3
+ template void BlockInfo::initialize(const DoFHandler<deal_II_dimension,deal_II_dimension+1>&);
+ template void BlockInfo::initialize(const MGDoFHandler<deal_II_dimension,deal_II_dimension+1>&, bool);
+ template void BlockInfo::initialize_local(const DoFHandler<deal_II_dimension,deal_II_dimension+1>&);
+#endif
+ }
+
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// --------------------------------------------------------------------------
-// explicit instantiations (for DoFHandler)
-
-#if deal_II_dimension == 1
-template class DoFAccessor<1, DoFHandler<1> >;
-#endif
-
-#if deal_II_dimension == 2
-template class DoFAccessor<1, DoFHandler<2> >;
-template class DoFAccessor<2, DoFHandler<2> >;
-
-template class TriaRawIterator <DoFAccessor<1, DoFHandler<2> > >;
-template class TriaIterator <DoFAccessor<1, DoFHandler<2> > >;
-template class TriaActiveIterator<DoFAccessor<1, DoFHandler<2> > >;
-#endif
-
-#if deal_II_dimension == 3
-template class DoFAccessor<1, DoFHandler<3> >;
-template class DoFAccessor<2, DoFHandler<3> >;
-template class DoFAccessor<3, DoFHandler<3> >;
-
-template class TriaRawIterator <DoFAccessor<1, DoFHandler<3> > >;
-template class TriaIterator <DoFAccessor<1, DoFHandler<3> > >;
-template class TriaActiveIterator<DoFAccessor<1, DoFHandler<3> > >;
-template class TriaRawIterator <DoFAccessor<2, DoFHandler<3> > >;
-template class TriaIterator <DoFAccessor<2, DoFHandler<3> > >;
-template class TriaActiveIterator<DoFAccessor<2, DoFHandler<3> > >;
-#endif
-
-
-template class DoFCellAccessor<DoFHandler<deal_II_dimension> >;
-
-template class TriaRawIterator <DoFCellAccessor<DoFHandler<deal_II_dimension> > >;
-template class TriaIterator <DoFCellAccessor<DoFHandler<deal_II_dimension> > >;
-template class TriaActiveIterator<DoFCellAccessor<DoFHandler<deal_II_dimension> > >;
-
-
-// --------------------------------------------------------------------------
-// explicit instantiations (for hp::DoFHandler)
-
-#if deal_II_dimension == 1
-template class DoFAccessor<1, hp::DoFHandler<1> >;
-#endif
-
-#if deal_II_dimension == 2
-template class DoFAccessor<1, hp::DoFHandler<2> >;
-template class DoFAccessor<2, hp::DoFHandler<2> >;
-
-template class TriaRawIterator <DoFAccessor<1, hp::DoFHandler<2> > >;
-template class TriaIterator <DoFAccessor<1, hp::DoFHandler<2> > >;
-template class TriaActiveIterator<DoFAccessor<1, hp::DoFHandler<2> > >;
-#endif
-
-
-#if deal_II_dimension == 3
-template class DoFAccessor<1, hp::DoFHandler<3> >;
-template class DoFAccessor<2, hp::DoFHandler<3> >;
-template class DoFAccessor<3, hp::DoFHandler<3> >;
-
-template class TriaRawIterator <DoFAccessor<1, hp::DoFHandler<3> > >;
-template class TriaIterator <DoFAccessor<1, hp::DoFHandler<3> > >;
-template class TriaActiveIterator<DoFAccessor<1, hp::DoFHandler<3> > >;
-template class TriaRawIterator <DoFAccessor<2, hp::DoFHandler<3> > >;
-template class TriaIterator <DoFAccessor<2, hp::DoFHandler<3> > >;
-template class TriaActiveIterator<DoFAccessor<2, hp::DoFHandler<3> > >;
-#endif
-
-
-template class DoFCellAccessor<hp::DoFHandler<deal_II_dimension> >;
-
-template class TriaRawIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension> > >;
-template class TriaIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension> > >;
-template class TriaActiveIterator<DoFCellAccessor<hp::DoFHandler<deal_II_dimension> > >;
-
-
-
-// // --------------------------------------------------------------------------
-// // explicit instantiations (for DoFHandler)
-
-#if deal_II_dimension == 1
-template class DoFAccessor<1, DoFHandler<1,2> >;
-#endif
-
-#if deal_II_dimension == 2
-template class DoFAccessor<1, DoFHandler<2,3> >;
-template class DoFAccessor<2, DoFHandler<2,3> >;
-
-template class TriaRawIterator <DoFAccessor<1, DoFHandler<2,3> > >;
-template class TriaIterator <DoFAccessor<1, DoFHandler<2,3> > >;
-template class TriaActiveIterator<DoFAccessor<1, DoFHandler<2,3> > >;
-#endif
-
-
-#if deal_II_dimension != 3
-template class DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> >;
-
-template class
-TriaRawIterator <DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
-template class
-TriaIterator <DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
-template class
-TriaActiveIterator<DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
-#endif
-
-// --------------------------------------------------------------------------
-// explicit instantiations (for hp::DoFHandler)
-
-#if deal_II_dimension == 1
-template class DoFAccessor<1, hp::DoFHandler<1,2> >;
-#endif
-
-#if deal_II_dimension == 2
-template class DoFAccessor<1, hp::DoFHandler<2,3> >;
-template class DoFAccessor<2, hp::DoFHandler<2,3> >;
-
-template class TriaRawIterator <DoFAccessor<1, hp::DoFHandler<2,3> > >;
-template class TriaIterator <DoFAccessor<1, hp::DoFHandler<2,3> > >;
-template class TriaActiveIterator<DoFAccessor<1, hp::DoFHandler<2,3> > >;
-#endif
-
-#if deal_II_dimension != 3
-template class DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >;
-
-template class
-TriaRawIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
-template class
-TriaIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
-template class
-TriaActiveIterator<DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
-#endif
-
-
+// explicit instantiations
#include "dof_accessor.inst"
DEAL_II_NAMESPACE_CLOSE
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
//---------------------------------------------------------------------------
-for (VEC : SERIAL_VECTORS; SCALAR : REAL_SCALARS)
- {
+// TODO: This could surely be made more systematic!
+for (deal_II_dimension : DIMENSIONS)
+ {
+// explicit instantiations (for DoFHandler)
+
+#if deal_II_dimension == 1
+ template class DoFAccessor<1, DoFHandler<1> >;
+#endif
+
+#if deal_II_dimension == 2
+ template class DoFAccessor<1, DoFHandler<2> >;
+ template class DoFAccessor<2, DoFHandler<2> >;
+
+ template class TriaRawIterator <DoFAccessor<1, DoFHandler<2> > >;
+ template class TriaIterator <DoFAccessor<1, DoFHandler<2> > >;
+ template class TriaActiveIterator<DoFAccessor<1, DoFHandler<2> > >;
+#endif
+
+#if deal_II_dimension == 3
+ template class DoFAccessor<1, DoFHandler<3> >;
+ template class DoFAccessor<2, DoFHandler<3> >;
+ template class DoFAccessor<3, DoFHandler<3> >;
+
+ template class TriaRawIterator <DoFAccessor<1, DoFHandler<3> > >;
+ template class TriaIterator <DoFAccessor<1, DoFHandler<3> > >;
+ template class TriaActiveIterator<DoFAccessor<1, DoFHandler<3> > >;
+ template class TriaRawIterator <DoFAccessor<2, DoFHandler<3> > >;
+ template class TriaIterator <DoFAccessor<2, DoFHandler<3> > >;
+ template class TriaActiveIterator<DoFAccessor<2, DoFHandler<3> > >;
+#endif
+
+
+ template class DoFCellAccessor<DoFHandler<deal_II_dimension> >;
+
+ template class TriaRawIterator <DoFCellAccessor<DoFHandler<deal_II_dimension> > >;
+ template class TriaIterator <DoFCellAccessor<DoFHandler<deal_II_dimension> > >;
+ template class TriaActiveIterator<DoFCellAccessor<DoFHandler<deal_II_dimension> > >;
+
+
+// --------------------------------------------------------------------------
+// explicit instantiations (for hp::DoFHandler)
+
+#if deal_II_dimension == 1
+ template class DoFAccessor<1, hp::DoFHandler<1> >;
+#endif
+
+#if deal_II_dimension == 2
+ template class DoFAccessor<1, hp::DoFHandler<2> >;
+ template class DoFAccessor<2, hp::DoFHandler<2> >;
+
+ template class TriaRawIterator <DoFAccessor<1, hp::DoFHandler<2> > >;
+ template class TriaIterator <DoFAccessor<1, hp::DoFHandler<2> > >;
+ template class TriaActiveIterator<DoFAccessor<1, hp::DoFHandler<2> > >;
+#endif
+
+
+#if deal_II_dimension == 3
+ template class DoFAccessor<1, hp::DoFHandler<3> >;
+ template class DoFAccessor<2, hp::DoFHandler<3> >;
+ template class DoFAccessor<3, hp::DoFHandler<3> >;
+
+ template class TriaRawIterator <DoFAccessor<1, hp::DoFHandler<3> > >;
+ template class TriaIterator <DoFAccessor<1, hp::DoFHandler<3> > >;
+ template class TriaActiveIterator<DoFAccessor<1, hp::DoFHandler<3> > >;
+ template class TriaRawIterator <DoFAccessor<2, hp::DoFHandler<3> > >;
+ template class TriaIterator <DoFAccessor<2, hp::DoFHandler<3> > >;
+ template class TriaActiveIterator<DoFAccessor<2, hp::DoFHandler<3> > >;
+#endif
+
+
+ template class DoFCellAccessor<hp::DoFHandler<deal_II_dimension> >;
+
+ template class TriaRawIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension> > >;
+ template class TriaIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension> > >;
+ template class TriaActiveIterator<DoFCellAccessor<hp::DoFHandler<deal_II_dimension> > >;
+
+
+
+// // --------------------------------------------------------------------------
+// // explicit instantiations (for DoFHandler)
+
+#if deal_II_dimension == 1
+ template class DoFAccessor<1, DoFHandler<1,2> >;
+#endif
+
+#if deal_II_dimension == 2
+ template class DoFAccessor<1, DoFHandler<2,3> >;
+ template class DoFAccessor<2, DoFHandler<2,3> >;
+
+ template class TriaRawIterator <DoFAccessor<1, DoFHandler<2,3> > >;
+ template class TriaIterator <DoFAccessor<1, DoFHandler<2,3> > >;
+ template class TriaActiveIterator<DoFAccessor<1, DoFHandler<2,3> > >;
+#endif
+
+
+#if deal_II_dimension != 3
+ template class DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> >;
+
+ template class
+ TriaRawIterator <DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
+ template class
+ TriaIterator <DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
+ template class
+ TriaActiveIterator<DoFCellAccessor<DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
+#endif
+
+// --------------------------------------------------------------------------
+// explicit instantiations (for hp::DoFHandler)
+
+#if deal_II_dimension == 1
+ template class DoFAccessor<1, hp::DoFHandler<1,2> >;
+#endif
+
+#if deal_II_dimension == 2
+ template class DoFAccessor<1, hp::DoFHandler<2,3> >;
+ template class DoFAccessor<2, hp::DoFHandler<2,3> >;
+
+ template class TriaRawIterator <DoFAccessor<1, hp::DoFHandler<2,3> > >;
+ template class TriaIterator <DoFAccessor<1, hp::DoFHandler<2,3> > >;
+ template class TriaActiveIterator<DoFAccessor<1, hp::DoFHandler<2,3> > >;
+#endif
+
+#if deal_II_dimension != 3
+ template class DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >;
+
+ template class
+ TriaRawIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
+ template class
+ TriaIterator <DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
+ template class
+ TriaActiveIterator<DoFCellAccessor<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > >;
+#endif
+ }
+
+
+for (VEC : SERIAL_VECTORS; SCALAR : REAL_SCALARS; deal_II_dimension : DIMENSIONS)
+ {
template
void
DoFCellAccessor<DoFHandler<deal_II_dimension> >::get_interpolated_dof_values
}
-for (VEC : SERIAL_VECTORS; SCALAR : REAL_SCALARS)
- {
+for (VEC : SERIAL_VECTORS; SCALAR : REAL_SCALARS; deal_II_dimension : DIMENSIONS)
+ {
template
void
DoFCellAccessor<hp::DoFHandler<deal_II_dimension> >::get_interpolated_dof_values
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
{
namespace DoFHandler
{
-
-#if deal_II_dimension == 1
-
unsigned int
DoFFaces<1>::memory_consumption () const
{
return 0;
}
-#endif
-#if deal_II_dimension == 2
-
unsigned int
DoFFaces<2>::memory_consumption () const
{
return MemoryConsumption::memory_consumption (lines);
}
-#endif
-#if deal_II_dimension == 3
-
unsigned int
DoFFaces<3>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (quads) +
MemoryConsumption::memory_consumption (lines) );
}
-
-#endif
-
}
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
}
- // explicit instantiations
- template unsigned int DoFObjects<1>::memory_consumption () const;
- template unsigned int DoFObjects<2>::memory_consumption () const;
- template unsigned int DoFObjects<3>::memory_consumption () const;
+
+ template <int dim>
+ template <int dh_dim, int spacedim>
+ void
+ DoFObjects<dim>::
+ set_dof_index (const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const unsigned int global_index)
+ {
+ Assert ((fe_index == dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
+ ExcMessage ("Only the default FE index is allowed for non-hp DoFHandler objects"));
+ Assert (local_index<dof_handler.get_fe().template n_dofs_per_object<dim>(),
+ ExcIndexRange (local_index, 0, dof_handler.get_fe().template n_dofs_per_object<dim>()));
+ Assert (obj_index * dof_handler.get_fe().template n_dofs_per_object<dim>()+local_index
+ <
+ dofs.size(),
+ ExcInternalError());
+
+ dofs[obj_index * dof_handler.get_fe()
+ .template n_dofs_per_object<dim>() + local_index] = global_index;
+ }
+ }
+}
+
+
+// explicit instantiations
+namespace internal
+{
+ namespace DoFHandler
+ {
+#include "dof_objects.inst"
}
}
+++ /dev/null
-//---------------------------------------------------------------------------
-// $Id$
-// Version: $Name$
-//
-// Copyright (C) 2006 by the deal.II authors
-//
-// This file is subject to QPL and may not be distributed
-// without copyright and license information. Please refer
-// to the file deal.II/doc/license.html for the text and
-// further information on this license.
-//
-//---------------------------------------------------------------------------
-
-
-#include <base/exceptions.h>
-#include <base/memory_consumption.h>
-#include <dofs/dof_objects.h>
-#include <dofs/dof_handler.h>
-#include <fe/fe.h>
-
-DEAL_II_NAMESPACE_OPEN
-
-namespace internal
-{
- namespace DoFHandler
- {
- template <int dim>
- template <int dh_dim, int spacedim>
- void
- DoFObjects<dim>::
- set_dof_index (const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index)
- {
- Assert ((fe_index == dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
- ExcMessage ("Only the default FE index is allowed for non-hp DoFHandler objects"));
- Assert (local_index<dof_handler.get_fe().template n_dofs_per_object<dim>(),
- ExcIndexRange (local_index, 0, dof_handler.get_fe().template n_dofs_per_object<dim>()));
- Assert (obj_index * dof_handler.get_fe().template n_dofs_per_object<dim>()+local_index
- <
- dofs.size(),
- ExcInternalError());
-
- dofs[obj_index * dof_handler.get_fe()
- .template n_dofs_per_object<dim>() + local_index] = global_index;
- }
-
-// explicit instantiations
-
- template class DoFObjects<1>;
-
- template
- unsigned int
- DoFObjects<1>::
- get_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index) const;
-
- template
- void
- DoFObjects<1>::
- set_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index);
-
-
- template class DoFObjects<2>;
-
- template
- unsigned int
- DoFObjects<2>::
- get_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index) const;
-
- template
- void
- DoFObjects<2>::
- set_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index);
-
- template class DoFObjects<3>;
-
- template
- unsigned int
- DoFObjects<3>::
- get_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index) const;
-
- template
- void
- DoFObjects<3>::
- set_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index);
-
-
-#if deal_II_dimension!=3
-
- template
- unsigned int
- DoFObjects<1>::
- get_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index) const;
-
- template
- void
- DoFObjects<1>::
- set_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index);
-
-
- template
- unsigned int
- DoFObjects<2>::
- get_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index) const;
-
- template
- void
- DoFObjects<2>::
- set_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index);
-
-
-#endif
-
-
- }
-}
-
-DEAL_II_NAMESPACE_CLOSE
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2006, 2010 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+
+
+for (deal_II_dimension : DIMENSIONS)
+ {
+ template class DoFObjects<deal_II_dimension>;
+ }
+
+
+for (deal_II_dimension, structdim : DIMENSIONS)
+ {
+ template
+ unsigned int
+ DoFObjects<structdim>::
+ get_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index) const;
+
+ template
+ void
+ DoFObjects<structdim>::
+ set_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const unsigned int global_index);
+
+#if (deal_II_dimension < 3) && (structdim < 3)
+
+ template
+ unsigned int
+ DoFObjects<structdim>::
+ get_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index) const;
+
+ template
+ void
+ DoFObjects<structdim>::
+ set_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const unsigned int global_index);
+#endif
+ }
+