#ifdef DEAL_II_HAVE_TECPLOT
-#ifdef DEAL_II_ANON_NAMESPACE_BOGUS_WARNING
-namespace TEC
-#else
namespace
-#endif
{
class TecplotMacros
{
const unsigned int vars_per_node = (spacedim+n_data_sets),
nodes_per_cell = GeometryInfo<dim>::vertices_per_cell;
-#ifdef DEAL_II_ANON_NAMESPACE_BOGUS_WARNING
- TEC::TecplotMacros tm(n_nodes, vars_per_node, n_cells, nodes_per_cell);
-#else
TecplotMacros tm(n_nodes, vars_per_node, n_cells, nodes_per_cell);
-#endif
int is_double = 0,
tec_debug = 0,
// given a permutation array,
// compute and return the inverse
// permutation
-#ifdef DEAL_II_ANON_NAMESPACE_BUG
- static
-#endif
inline
std::vector<unsigned int>
invert_numbering (const std::vector<unsigned int> &in)
// performance reasons. this clears a
// dim-array
template <int dim>
-#ifdef DEAL_II_ANON_NAMESPACE_BUG
- static
-#endif
inline
void
zero_indices (unsigned int indices[dim])
// performance reasons. this increments tensor
// product indices
template <int dim>
-#ifdef DEAL_II_ANON_NAMESPACE_BUG
- static
-#endif
inline
void
increment_indices (unsigned int indices[dim],
// creates them from dim-dimensional support
// points.
template <int dim>
-#ifdef DEAL_II_ANON_NAMESPACE_BUG
- static
-#endif
inline
std::vector<Polynomials::Polynomial<double> >
generate_poly_space1d (const std::vector<Point<dim> > &unit_support_points,
// them. used to initialize
// fe_name_map below
template <int dim>
-#ifdef DEAL_II_ANON_NAMESPACE_BUG
- static
-#endif
std::map<std::string,std_cxx1x::shared_ptr<const FETools::FEFactoryBase<dim> > >
get_default_fe_names ()
{
std::vector<Point<dim> > q_points_coarse(q_points_fine.size());
for (unsigned int q=0;q<q_points_fine.size();++q)
for (unsigned int j=0;j<dim;++j)
- q_points_coarse[q](j) = q_points_fine[q](j);
+ q_points_coarse[q](j) = q_points_fine[q](j);
Quadrature<dim> q_coarse (q_points_coarse,
fine.get_JxW_values());
FEValues<dim,spacedim> coarse (mapping, fe, q_coarse, update_values);
// define some transformations in an anonymous namespace
-#ifdef DEAL_II_ANON_NAMESPACE_BOGUS_WARNING
- namespace TRANS
-#else
namespace
-#endif
{
template <int spacedim>
class ShiftPoint
shift (const Point<spacedim> &shift_vector,
Triangulation<dim, spacedim> &triangulation)
{
-#ifdef DEAL_II_ANON_NAMESPACE_BOGUS_WARNING
- transform (TRANS::ShiftPoint<spacedim>(shift_vector), triangulation);
-#else
transform (ShiftPoint<spacedim>(shift_vector), triangulation);
-#endif
}
rotate (const double angle,
Triangulation<2> &triangulation)
{
-#ifdef DEAL_II_ANON_NAMESPACE_BOGUS_WARNING
- transform (TRANS::Rotate2d(angle), triangulation);
-#else
transform (Rotate2d(angle), triangulation);
-#endif
}
Triangulation<dim, spacedim> &triangulation)
{
Assert (scaling_factor>0, ExcScalingFactorNotPositive (scaling_factor));
-#ifdef DEAL_II_ANON_NAMESPACE_BOGUS_WARNING
- transform (TRANS::ScalePoint<spacedim>(scaling_factor), triangulation);
-#else
transform (ScalePoint<spacedim>(scaling_factor), triangulation);
-#endif
}