#include <base/table.h>
#include <base/geometry_info.h>
+#include <boost/tuple/tuple.hpp>
+
#include <vector>
#include <string>
* current readers and
* writers understand.
*/
- static const unsigned int format_version = 2;
+ static const unsigned int format_version = 3;
private:
/**
* Dummy entry to suppress compiler
template <int dim, int spacedim>
static void write_dx (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
- const DXFlags &flags,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+ const DXFlags &flags,
std::ostream &out);
/**
template <int dim, int spacedim>
static void write_eps (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const EpsFlags &flags,
std::ostream &out);
template <int dim, int spacedim>
static void write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const GmvFlags &flags,
std::ostream &out);
template <int dim, int spacedim>
static void write_gnuplot (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const GnuplotFlags &flags,
std::ostream &out);
template <int dim, int spacedim>
static void write_povray (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const PovrayFlags &flags,
std::ostream &out);
template <int dim, int spacedim>
static void write_tecplot (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const TecplotFlags &flags,
std::ostream &out);
static void write_tecplot_binary (
const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const TecplotFlags &flags,
std::ostream &out);
template <int dim, int spacedim>
static void write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const UcdFlags &flags,
std::ostream &out);
* SoftwareVTK format.
*
* This is the file format used by @ref SoftwareVTK, as described in
- * their manual, section 14.3. It is similar to write_gmv().
+ * their manual, section 14.3.
+ *
+ * The vector_data_ranges argument denotes ranges of components in the
+ * output that are considered a vector, rather than simply a
+ * collection of scalar fields. The VTK output format has special
+ * provisions that allow these components to be output by a single
+ * name rather than having to group several scalar fields into a
+ * vector later on in the visualization program.
*/
template <int dim, int spacedim>
static void write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const VtkFlags &flags,
std::ostream &out);
static void write_deal_II_intermediate (
const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const Deal_II_IntermediateFlags &flags,
std::ostream &out);
* output functions to know what
* they shall print.
*/
- virtual const std::vector<typename DataOutBase::Patch<dim,spacedim> > &
+ virtual
+ const std::vector<typename DataOutBase::Patch<dim,spacedim> > &
get_patches () const = 0;
/**
* output functions of the base
* class.
*/
- virtual std::vector<std::string> get_dataset_names () const = 0;
+ virtual
+ std::vector<std::string>
+ get_dataset_names () const = 0;
+ /**
+ * This functions returns
+ * information about how the
+ * individual components of
+ * output files that consist of
+ * more than one data set are to
+ * be interpreted.
+ *
+ * It returns a list of index
+ * pairs and corresponding name
+ * indicating which components of
+ * the output are to be
+ * considered vector-valued
+ * rather than just a collection
+ * of scalar data. The index
+ * pairs are inclusive; for
+ * example, if we have a Stokes
+ * problem in 2d with components
+ * (u,v,p), then the
+ * corresponding vector data
+ * range should be (0,1), and the
+ * returned list would consist of
+ * only a single element with a
+ * tuple such as (0,1,"velocity").
+ *
+ * Since some of the derived
+ * classes do not know about
+ * vector data, this function has
+ * a default implementation that
+ * simply returns an empty
+ * string, meaning that all data
+ * is to be considered a
+ * collection of scalar fields.
+ */
+ virtual
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+ get_vector_data_ranges () const;
+
/**
* The default number of
* subdivisions for patches. This
*/
virtual std::vector<std::string> get_dataset_names () const;
+ /**
+ * This functions returns
+ * information about how the
+ * individual components of
+ * output files that consist of
+ * more than one data set are to
+ * be interpreted.
+ *
+ * It returns a list of index
+ * pairs and corresponding name
+ * indicating which components of
+ * the output are to be
+ * considered vector-valued
+ * rather than just a collection
+ * of scalar data. The index
+ * pairs are inclusive; for
+ * example, if we have a Stokes
+ * problem in 2d with components
+ * (u,v,p), then the
+ * corresponding vector data
+ * range should be (0,1), and the
+ * returned list would consist of
+ * only a single element with a
+ * tuple such as (0,1,"velocity").
+ *
+ * Since some of the derived
+ * classes do not know about
+ * vector data, this function has
+ * a default implementation that
+ * simply returns an empty
+ * string, meaning that all data
+ * is to be considered a
+ * collection of scalar fields.
+ */
+ virtual
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+ get_vector_data_ranges () const;
+
private:
/**
* Arrays holding the set of
- * patches that will be filled by
- * derived classes as well as the
- * names of output variables.
+ * patches as well as the names
+ * of output variables, all of
+ * which we read from an input
+ * stream.
*/
std::vector<typename dealii::DataOutBase::Patch<dim,spacedim> > patches;
std::vector<std::string> dataset_names;
+
+ /**
+ * Information about whether
+ * certain components of the
+ * output field are to be
+ * considered vectors.
+ */
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+ vector_data_ranges;
};
{}
+
unsigned int
DataOutBase::VtkFlags::memory_consumption () const
{
template <int dim, int spacedim>
void DataOutBase::write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
const UcdFlags &flags,
std::ostream &out)
{
template <int dim, int spacedim>
void DataOutBase::write_dx (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
const DXFlags &flags,
std::ostream &out)
{
template <int dim, int spacedim>
void DataOutBase::write_gnuplot (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
const GnuplotFlags &/*flags*/,
std::ostream &out)
{
template <int dim, int spacedim>
void DataOutBase::write_povray (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
const PovrayFlags &flags,
std::ostream &out)
{
template <int dim, int spacedim>
void DataOutBase::write_eps (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &/*data_names*/,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
const EpsFlags &flags,
std::ostream &out)
{
template <int dim, int spacedim>
void DataOutBase::write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
const GmvFlags &flags,
std::ostream &out)
{
template <int dim, int spacedim>
void DataOutBase::write_tecplot (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
const TecplotFlags &flags,
std::ostream &out)
{
template <int dim, int spacedim>
void DataOutBase::write_tecplot_binary (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const TecplotFlags &flags,
std::ostream &out)
{
// simply call the ASCII output
// function if the Tecplot API
// isn't present
- write_tecplot (patches, data_names, flags, out);
+ write_tecplot (patches, data_names, vector_data_ranges, flags, out);
return;
#else
// for 2D & 3D
if (dim == 1)
{
- write_tecplot (patches, data_names, flags, out);
+ write_tecplot (patches, data_names, vector_data_ranges, flags, out);
return;
}
template <int dim, int spacedim>
-void DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
- const std::vector<std::string> &data_names,
- const VtkFlags &flags,
- std::ostream &out)
+void
+DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
+ const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+ const VtkFlags &flags,
+ std::ostream &out)
{
AssertThrow (out, ExcIO());
Assert (patches.size() > 0, ExcNoPatches());
+
VtkStream vtk_out(out, flags);
const unsigned int n_data_sets = data_names.size();
// write_gmv_reorder_data_vectors
Assert ((patches[0].data.n_rows() == n_data_sets && !patches[0].points_are_available) ||
(patches[0].data.n_rows() == n_data_sets+spacedim && patches[0].points_are_available),
- ExcDimensionMismatch (patches[0].points_are_available ? (patches[0].data.n_rows() + spacedim) : patches[0].data.n_rows(), n_data_sets));
+ ExcDimensionMismatch (patches[0].points_are_available
+ ?
+ (patches[0].data.n_rows() + spacedim)
+ :
+ patches[0].data.n_rows(), n_data_sets));
///////////////////////
// are point data
out << "POINT_DATA " << n_nodes
<< '\n';
- for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
+
+ // when writing, first write out
+ // all vector data, then handle the
+ // scalar data sets that have been
+ // left over
+ std::vector<bool> data_set_written (n_data_sets, false);
+ for (unsigned int n_th_vector=0; n_th_vector<vector_data_ranges.size(); ++n_th_vector)
{
- out << "SCALARS "
- << data_names[data_set]
- << " double 1"
- << '\n'
- << "LOOKUP_TABLE default"
+
+ AssertThrow (vector_data_ranges[n_th_vector].get<1>() >
+ vector_data_ranges[n_th_vector].get<0>(),
+ ExcLowerRange (vector_data_ranges[n_th_vector].get<1>(),
+ vector_data_ranges[n_th_vector].get<0>()));
+ AssertThrow (vector_data_ranges[n_th_vector].get<1>() < n_data_sets,
+ ExcIndexRange (vector_data_ranges[n_th_vector].get<1>(),
+ 0, n_data_sets));
+ AssertThrow (vector_data_ranges[n_th_vector].get<1>() + 1
+ - vector_data_ranges[n_th_vector].get<0>() <= 3,
+ ExcMessage ("Can't declare a vector with more than 3 components "
+ "in VTK"));
+
+ // mark these components as already written:
+ for (unsigned int i=vector_data_ranges[n_th_vector].get<0>();
+ i<=vector_data_ranges[n_th_vector].get<1>();
+ ++i)
+ data_set_written[i] = true;
+
+ // write the
+ // header. concatenate all the
+ // component names with double
+ // underscores unless a vector
+ // name has been specified
+ out << "VECTORS ";
+
+ if (vector_data_ranges[n_th_vector].get<2>() != "")
+ out << vector_data_ranges[n_th_vector].get<2>();
+ else
+ {
+ for (unsigned int i=vector_data_ranges[n_th_vector].get<0>();
+ i<vector_data_ranges[n_th_vector].get<1>();
+ ++i)
+ out << data_names[i] << "__";
+ out << data_names[vector_data_ranges[n_th_vector].get<1>()];
+ }
+
+ out << " double"
<< '\n';
- std::copy (data_vectors[data_set].begin(),
- data_vectors[data_set].end(),
- std::ostream_iterator<double>(out, " "));
- out << '\n';
+
+ // now write data. pad all
+ // vectors to have three
+ // components
+ for (unsigned int n=0; n<n_nodes; ++n)
+ {
+ switch (vector_data_ranges[n_th_vector].get<1>() -
+ vector_data_ranges[n_th_vector].get<0>())
+ {
+ case 0:
+ out << data_vectors(vector_data_ranges[n_th_vector].get<0>(), n) << " 0 0"
+ << '\n';
+ break;
+
+ case 1:
+ out << data_vectors(vector_data_ranges[n_th_vector].get<0>(), n) << ' '
+ << data_vectors(vector_data_ranges[n_th_vector].get<0>()+1, n) << " 0"
+ << '\n';
+ break;
+ case 2:
+ out << data_vectors(vector_data_ranges[n_th_vector].get<0>(), n) << ' '
+ << data_vectors(vector_data_ranges[n_th_vector].get<0>()+1, n) << ' '
+ << data_vectors(vector_data_ranges[n_th_vector].get<0>()+2, n)
+ << '\n';
+ break;
+
+ default:
+ // VTK doesn't
+ // support
+ // anything else
+ // than vectors
+ // with 1, 2, or
+ // 3 components
+ Assert (false, ExcInternalError());
+ }
+ }
}
+
+ // now do the left over scalar data sets
+ for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
+ if (data_set_written[data_set] == false)
+ {
+ out << "SCALARS "
+ << data_names[data_set]
+ << " double 1"
+ << '\n'
+ << "LOOKUP_TABLE default"
+ << '\n';
+ std::copy (data_vectors[data_set].begin(),
+ data_vectors[data_set].end(),
+ std::ostream_iterator<double>(out, " "));
+ out << '\n';
+ }
// make sure everything now gets to
// disk
DataOutBase::
write_deal_II_intermediate (const std::vector<Patch<dim,spacedim> > &patches,
const std::vector<std::string> &data_names,
+ const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
const Deal_II_IntermediateFlags &/*flags*/,
std::ostream &out)
{
for (unsigned int i=0; i<patches.size(); ++i)
out << patches[i] << '\n';
+ out << vector_data_ranges.size() << '\n';
+ for (unsigned int i=0; i<vector_data_ranges.size(); ++i)
+ out << vector_data_ranges[i].get<0>() << ' '
+ << vector_data_ranges[i].get<1>() << '\n'
+ << vector_data_ranges[i].get<2>() << '\n';
+
out << '\n';
// make sure everything now gets to
// disk
void DataOutInterface<dim,spacedim>::write_dx (std::ostream &out) const
{
DataOutBase::write_dx (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
dx_flags, out);
}
void DataOutInterface<dim,spacedim>::write_ucd (std::ostream &out) const
{
DataOutBase::write_ucd (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
ucd_flags, out);
}
void DataOutInterface<dim,spacedim>::write_gnuplot (std::ostream &out) const
{
DataOutBase::write_gnuplot (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
gnuplot_flags, out);
}
void DataOutInterface<dim,spacedim>::write_povray (std::ostream &out) const
{
DataOutBase::write_povray (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
povray_flags, out);
}
void DataOutInterface<dim,spacedim>::write_eps (std::ostream &out) const
{
DataOutBase::write_eps (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
eps_flags, out);
}
void DataOutInterface<dim,spacedim>::write_gmv (std::ostream &out) const
{
DataOutBase::write_gmv (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
gmv_flags, out);
}
void DataOutInterface<dim,spacedim>::write_tecplot (std::ostream &out) const
{
DataOutBase::write_tecplot (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
tecplot_flags, out);
}
void DataOutInterface<dim,spacedim>::write_tecplot_binary (std::ostream &out) const
{
DataOutBase::write_tecplot_binary (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
tecplot_flags, out);
}
void DataOutInterface<dim,spacedim>::write_vtk (std::ostream &out) const
{
DataOutBase::write_vtk (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
vtk_flags, out);
}
write_deal_II_intermediate (std::ostream &out) const
{
DataOutBase::write_deal_II_intermediate (get_patches(), get_dataset_names(),
+ get_vector_data_ranges(),
deal_II_intermediate_flags, out);
}
+template <int dim, int spacedim>
+std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+DataOutInterface<dim,spacedim>::get_vector_data_ranges () const
+{
+ return std::vector<boost::tuple<unsigned int, unsigned int, std::string> >();
+}
+
+
+
+
+// ---------------------------------------------- DataOutReader ----------
template <int dim, int spacedim>
void
std::vector<std::string> tmp;
tmp.swap (dataset_names);
}
-
+ {
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > tmp;
+ tmp.swap (vector_data_ranges);
+ }
+
// then check that we have the
// correct header of this
// file. both the first and second
patches.resize (n_patches);
for (unsigned int i=0; i<n_patches; ++i)
in >> patches[i];
+
+ unsigned int n_vector_data_ranges;
+ in >> n_vector_data_ranges;
+ vector_data_ranges.resize (n_vector_data_ranges);
+ for (unsigned int i=0; i<n_patches; ++i)
+ {
+ in >> vector_data_ranges[i].get<0>()
+ >> vector_data_ranges[i].get<1>();
+ std::string name;
+ getline(in, name);
+ vector_data_ranges[i].get<2>() = name;
+ }
Assert (in, ExcIO());
}
+template <int dim, int spacedim>
+std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+DataOutReader<dim,spacedim>::get_vector_data_ranges () const
+{
+ return vector_data_ranges;
+}
+
+
+
template <int dim, int spacedim>
std::ostream &
</p>
<ol>
+ <li> <p>Changed: The version number of the deal.II intermediate format written by
+ DataOutBase::write_deal_intermediate has been increased to 3 to accomodate the fact that
+ we now support writing vector-valued data to output files in at least some output formats.
+ (Previously, vector-valued date was written as a collection of scalar fields.) Since
+ we can only read files written in intermediate format that has the same number as the
+ files we generate, this means that files written with previous format numbers can now
+ no longer be read.
+ <br>
+ (WB 2007/10/11)
+ </p>
-<li> <p>Changed: FilteredMatrix now can be applied to any matrix having the standard
-set of <code>vmult</code> functions. In order to achieve this, its interface had to be overhauled.
-Only the <code>VECTOR</code> template argument remains. Furthermore, instead of
-PreconditionJacobi being applied to FilteredMatrix, FilteredMatrix
-can now be applied to any preconditioner.
-<br>
-(GK 2007/09/25)
-</p>
+ <li> <p>Changed: FilteredMatrix now can be applied to any matrix having the standard
+ set of <code>vmult</code> functions. In order to achieve this, its interface had to be overhauled.
+ Only the <code>VECTOR</code> template argument remains. Furthermore, instead of
+ PreconditionJacobi being applied to FilteredMatrix, FilteredMatrix
+ can now be applied to any preconditioner.
+ <br>
+ (GK 2007/09/25)
+ </p>
<li> <p>Changed: The deprecated typedefs
<code>internal::Triangulation::Line</code>,
<ol>
+ <li> <p>New: The DataOutBase class and derived classes can now deal with data that is
+ logically vector-valued, i.e. derived classes can pass down information that some of
+ the components of the output should be grouped together as vectors, instead of being
+ treated as a number of separate scalar fields. This allows visualization programs to
+ display these components as vector-fields right away, without the need to manually group
+ them together into a vector.
+ <p>
+ While all output format writers receive the information necessary to do this, currently
+ only the VTK reader in DataOutBase::write_vtk makes use of it.
+ <p>
+ The use of this ability is explained in the @ref step_22 "step-22" tutorial program.
+ <br>
+ (WB 2007/10/11)
+ </p> </li>
+
<li> <p>New: Macro #AssertDimension introduced for easier handling of
ExcDimensionMismatch.
<br>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#define WRITE(type) { out << "Writing " # type " dimensions " \
<< dim << ',' << spacedim << std::endl; \
-DataOutBase::write_ ## type (patches, names, type ## flags, out); }
+DataOutBase::write_ ## type (patches, names, vectors, type ## flags, out); }
template <int dim, int spacedim>
void
DataOutBase::UcdFlags ucdflags;
DataOutBase::VtkFlags vtkflags;
DataOutBase::Deal_II_IntermediateFlags deal_II_intermediateflags;
+
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
WRITE(dx);
if (dim==2)
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
first name
last name
0.00000 1.00000 2.00000 3.00000 0.00000 -1.00000 -2.00000 -3.00000
+0
Writing dx dimensions 2,2
object "vertices" class array type float rank 1 shape 2 items 64 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
first name
last name
0.00000 1.00000 2.00000 3.00000 4.00000 5.00000 6.00000 7.00000 8.00000 9.00000 10.0000 11.0000 12.0000 13.0000 14.0000 15.0000 0.00000 -1.00000 -2.00000 -3.00000 -4.00000 -5.00000 -6.00000 -7.00000 -8.00000 -9.00000 -10.0000 -11.0000 -12.0000 -13.0000 -14.0000 -15.0000
+0
Writing dx dimensions 2,3
object "vertices" class array type float rank 1 shape 3 items 64 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
first name
last name
0.00000 1.00000 2.00000 3.00000 4.00000 5.00000 6.00000 7.00000 8.00000 9.00000 10.0000 11.0000 12.0000 13.0000 14.0000 15.0000 0.00000 -1.00000 -2.00000 -3.00000 -4.00000 -5.00000 -6.00000 -7.00000 -8.00000 -9.00000 -10.0000 -11.0000 -12.0000 -13.0000 -14.0000 -15.0000
+0
Writing dx dimensions 3,3
object "vertices" class array type float rank 1 shape 3 items 512 data follows
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
first name
last name
0.00000 1.00000 2.00000 3.00000 4.00000 5.00000 6.00000 7.00000 8.00000 9.00000 10.0000 11.0000 12.0000 13.0000 14.0000 15.0000 16.0000 17.0000 18.0000 19.0000 20.0000 21.0000 22.0000 23.0000 24.0000 25.0000 26.0000 27.0000 28.0000 29.0000 30.0000 31.0000 32.0000 33.0000 34.0000 35.0000 36.0000 37.0000 38.0000 39.0000 40.0000 41.0000 42.0000 43.0000 44.0000 45.0000 46.0000 47.0000 48.0000 49.0000 50.0000 51.0000 52.0000 53.0000 54.0000 55.0000 56.0000 57.0000 58.0000 59.0000 60.0000 61.0000 62.0000 63.0000 0.00000 -1.00000 -2.00000 -3.00000 -4.00000 -5.00000 -6.00000 -7.00000 -8.00000 -9.00000 -10.0000 -11.0000 -12.0000 -13.0000 -14.0000 -15.0000 -16.0000 -17.0000 -18.0000 -19.0000 -20.0000 -21.0000 -22.0000 -23.0000 -24.0000 -25.0000 -26.0000 -27.0000 -28.0000 -29.0000 -30.0000 -31.0000 -32.0000 -33.0000 -34.0000 -35.0000 -36.0000 -37.0000 -38.0000 -39.0000 -40.0000 -41.0000 -42.0000 -43.0000 -44.0000 -45.0000 -46.0000 -47.0000 -48.0000 -49.0000 -50.0000 -51.0000 -52.0000 -53.0000 -54.0000 -55.0000 -56.0000 -57.0000 -58.0000 -59.0000 -60.0000 -61.0000 -62.0000 -63.0000
+0
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
names[2] = "x3";
names[3] = "x4";
names[4] = "i";
- DataOutBase::write_dx(patches, names, flags, out);
+
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+
+ DataOutBase::write_dx(patches, names, vectors, flags, out);
}
std::vector<std::string> names(1);
names[0] = "CutOff";
- DataOutBase::write_dx(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_dx(patches, names, vectors, flags, out);
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
names[2] = "x3";
names[3] = "x4";
names[4] = "i";
- DataOutBase::write_eps(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_eps(patches, names, vectors, flags, out);
}
std::vector<std::string> names(1);
names[0] = "CutOff";
- DataOutBase::write_eps(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_eps(patches, names, vectors, flags, out);
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
names[2] = "x3";
names[3] = "x4";
names[4] = "i";
- DataOutBase::write_gmv(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_gmv(patches, names, vectors, flags, out);
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
names[2] = "x3";
names[3] = "x4";
names[4] = "i";
- DataOutBase::write_gnuplot(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_gnuplot(patches, names, vectors, flags, out);
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
names[2] = "x3";
names[3] = "x4";
names[4] = "i";
- DataOutBase::write_povray(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_povray(patches, names, vectors, flags, out);
}
std::vector<std::string> names(1);
names[0] = "CutOff";
- DataOutBase::write_povray(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_povray(patches, names, vectors, flags, out);
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
names[2] = "x3";
names[3] = "x4";
names[4] = "i";
- DataOutBase::write_tecplot(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_tecplot(patches, names, vectors, flags, out);
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2007 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
names[2] = "x3";
names[3] = "x4";
names[4] = "i";
- DataOutBase::write_vtk(patches, names, flags, out);
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+ DataOutBase::write_vtk(patches, names, vectors, flags, out);
}
DataOutBase dout;
DataOutBase::DXFlags dxflags;
DataOutBase::GnuplotFlags gflags;
+ std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
if (dim==2)
- dout.write_gnuplot(patches, names, gflags, out);
+ dout.write_gnuplot(patches, names, vectors, gflags, out);
else
- dout.write_dx(patches, names, dxflags, out);
+ dout.write_dx(patches, names, vectors, dxflags, out);
}
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.0 0.0 2.0 2.0
+0
DEAL::Checking Q1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
11. 12. 13. 2.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
33. 36. 39. 40. 43. 44. 45. 6.0 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking Q2 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 0.0 2.0 2.0
+0
DEAL::Checking Q2 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
24. 30. 35. 2.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.2e+02 1.5e+02 1.6e+02 1.8e+02 1.9e+02 2.1e+02 2.2e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking Q3 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
5.0 0.0 2.0 2.0
+0
DEAL::Checking Q3 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
43. 56. 67. 2.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.2e+02 3.8e+02 4.3e+02 4.7e+02 5.1e+02 5.6e+02 5.9e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking DGQ0 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2.0 2.0 2.0 2.0
+0
DEAL::Checking DGQ0 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking DGQ1 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 5.0 2.0 2.0
+0
DEAL::Checking DGQ1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
24. 25. 26. 27. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.1e+02 1.1e+02 1.1e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking DGQ2 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 8.0 2.0 2.0
+0
DEAL::Checking DGQ2 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
54. 56. 60. 62. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.8e+02 3.8e+02 3.8e+02 3.9e+02 4.0e+02 4.0e+02 4.0e+02 4.0e+02 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking Nedelec1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
3
node_data_0
node_data_1
64. 64. 84. 84. 72. 80. 72. 80. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
4
node_data_0
node_data_1
2.7e+02 2.7e+02 3.3e+02 3.3e+02 3.8e+02 3.8e+02 4.1e+02 4.1e+02 3.0e+02 3.2e+02 3.0e+02 3.2e+02 3.9e+02 4.1e+02 3.9e+02 4.1e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 14. 14. 14. 14. 14. 14. 14. 14.
+0
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.0 0.0 2.0 2.0
+0
DEAL::Checking Q1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
11. 12. 13. 2.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
33. 36. 39. 40. 43. 44. 45. 6.0 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking Q2 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 0.0 2.0 2.0
+0
DEAL::Checking Q2 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
24. 30. 35. 2.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.2e+02 1.5e+02 1.6e+02 1.8e+02 1.9e+02 2.1e+02 2.2e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking Q3 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
5.0 0.0 2.0 2.0
+0
DEAL::Checking Q3 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
43. 56. 67. 2.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.2e+02 3.8e+02 4.3e+02 4.7e+02 5.1e+02 5.6e+02 5.9e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking DGQ0 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2.0 2.0 2.0 2.0
+0
DEAL::Checking DGQ0 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking DGQ1 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 5.0 2.0 2.0
+0
DEAL::Checking DGQ1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
24. 25. 26. 27. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.1e+02 1.1e+02 1.1e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking DGQ2 in 1d:
object "vertices" class array type float rank 1 shape 1 items 6 data follows
1 1
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 8.0 2.0 2.0
+0
DEAL::Checking DGQ2 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
54. 56. 60. 62. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.8e+02 3.8e+02 3.8e+02 3.9e+02 4.0e+02 4.0e+02 4.0e+02 4.0e+02 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking Nedelec1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 28 data follows
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
3
node_data_0
node_data_1
64. 64. 84. 84. 72. 80. 72. 80. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
4
node_data_0
node_data_1
2.7e+02 2.7e+02 3.3e+02 3.3e+02 3.8e+02 3.8e+02 4.1e+02 4.1e+02 3.0e+02 3.2e+02 3.0e+02 3.2e+02 3.9e+02 4.1e+02 3.9e+02 4.1e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 14. 14. 14. 14. 14. 14. 14. 14.
+0
DEAL::Checking Q1 in 1d:
-DEAL::OK
-DEAL::Checking Q1 in 2d:
-DEAL::OK
-DEAL::Checking Q1 in 3d:
-DEAL::OK
-DEAL::Checking Q2 in 1d:
-DEAL::OK
-DEAL::Checking Q2 in 2d:
-DEAL::OK
-DEAL::Checking Q2 in 3d:
-DEAL::OK
-DEAL::Checking Q3 in 1d:
-DEAL::OK
-DEAL::Checking Q3 in 2d:
-DEAL::OK
-DEAL::Checking Q3 in 3d:
-DEAL::OK
-DEAL::Checking DGQ0 in 1d:
-DEAL::OK
-DEAL::Checking DGQ0 in 2d:
-DEAL::OK
-DEAL::Checking DGQ0 in 3d:
-DEAL::OK
-DEAL::Checking DGQ1 in 1d:
-DEAL::OK
-DEAL::Checking DGQ1 in 2d:
-DEAL::OK
-DEAL::Checking DGQ1 in 3d:
-DEAL::OK
-DEAL::Checking DGQ2 in 1d:
-DEAL::OK
-DEAL::Checking DGQ2 in 2d:
-DEAL::OK
-DEAL::Checking DGQ2 in 3d:
-DEAL::OK
-DEAL::Checking Nedelec1 in 2d:
-DEAL::OK
-DEAL::Checking Nedelec1 in 3d:
-DEAL::OK
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
10. 4.0 5.0 5.0
+0
DEAL::Checking Q1 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
32. 38. 42. 11. 13. 13. 13. 13.
+0
DEAL::Checking Q2 in 1d:
DEAL::Checking Q2 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
23. 9.0 5.0 5.0
+0
DEAL::Checking Q2 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.2e+02 1.6e+02 1.9e+02 30. 13. 13. 13. 13.
+0
DEAL::Checking Q3 in 1d:
DEAL::Checking Q3 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
42. 16. 5.0 5.0
+0
DEAL::Checking Q3 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.2e+02 4.3e+02 5.1e+02 67. 13. 13. 13. 13.
+0
DEAL::Checking DGQ0 in 1d:
DEAL::Checking DGQ0 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
5.0 5.0 5.0 5.0
+0
DEAL::Checking DGQ0 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
13. 13. 13. 13. 13. 13. 13. 13.
+0
DEAL::Checking DGQ1 in 1d:
DEAL::Checking DGQ1 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
20. 22. 5.0 5.0
+0
DEAL::Checking DGQ1 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.0e+02 1.1e+02 1.1e+02 1.1e+02 13. 13. 13. 13.
+0
DEAL::Checking DGQ2 in 1d:
DEAL::Checking DGQ2 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
45. 51. 5.0 5.0
+0
DEAL::Checking DGQ2 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.5e+02 3.6e+02 3.7e+02 3.8e+02 13. 13. 13. 13.
+0
DEAL::Checking Nedelec1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 20 data follows
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
3
node_data_0
node_data_1
52. 76. 68. 68. 5.0 5.0
+0
DEAL::Checking Nedelec1 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
4
node_data_0
node_data_1
2.3e+02 3.0e+02 3.5e+02 4.0e+02 3.0e+02 3.0e+02 3.9e+02 3.9e+02 3.6e+02 4.0e+02 3.6e+02 4.0e+02 13. 13. 13. 13.
+0
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
10. 4.0 5.0 5.0
+0
DEAL::Checking Q1 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
32. 38. 42. 11. 13. 13. 13. 13.
+0
DEAL::Checking Q2 in 1d:
DEAL::Checking Q2 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
23. 9.0 5.0 5.0
+0
DEAL::Checking Q2 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.2e+02 1.6e+02 1.9e+02 30. 13. 13. 13. 13.
+0
DEAL::Checking Q3 in 1d:
DEAL::Checking Q3 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
42. 16. 5.0 5.0
+0
DEAL::Checking Q3 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.2e+02 4.3e+02 5.1e+02 67. 13. 13. 13. 13.
+0
DEAL::Checking DGQ0 in 1d:
DEAL::Checking DGQ0 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
5.0 5.0 5.0 5.0
+0
DEAL::Checking DGQ0 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
13. 13. 13. 13. 13. 13. 13. 13.
+0
DEAL::Checking DGQ1 in 1d:
DEAL::Checking DGQ1 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
20. 22. 5.0 5.0
+0
DEAL::Checking DGQ1 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
1.0e+02 1.1e+02 1.1e+02 1.1e+02 13. 13. 13. 13.
+0
DEAL::Checking DGQ2 in 1d:
DEAL::Checking DGQ2 in 2d:
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
45. 51. 5.0 5.0
+0
DEAL::Checking DGQ2 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.5e+02 3.6e+02 3.7e+02 3.8e+02 13. 13. 13. 13.
+0
DEAL::Checking Nedelec1 in 2d:
object "vertices" class array type float rank 1 shape 2 items 20 data follows
1 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
3
node_data_0
node_data_1
52. 76. 68. 68. 5.0 5.0
+0
DEAL::Checking Nedelec1 in 3d:
object "vertices" class array type float rank 1 shape 3 items 132 data follows
2 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
4
node_data_0
node_data_1
2.3e+02 3.0e+02 3.5e+02 4.0e+02 3.0e+02 3.0e+02 3.9e+02 3.9e+02 3.6e+02 4.0e+02 3.6e+02 4.0e+02 13. 13. 13. 13.
+0
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3.0 3.0 0.0 0.0 2.0 2.0 2.0 2.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
11. 11. 12. 12. 13. 13. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
DEAL::Checking Q1 in 3d:
DEAL::Checking Q2 in 1d:
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 4.0 0.0 0.0 2.0 2.0 2.0 2.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
24. 24. 30. 30. 35. 35. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
DEAL::Checking Q2 in 3d:
DEAL::Checking Q3 in 1d:
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
5.0 5.0 0.0 0.0 2.0 2.0 2.0 2.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
43. 43. 56. 56. 67. 67. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
DEAL::Checking Q3 in 3d:
DEAL::Checking DGQ0 in 1d:
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2.0 2.0 2.0 2.0 2.0 2.0 2.0 2.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
DEAL::Checking DGQ0 in 3d:
DEAL::Checking DGQ1 in 1d:
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 4.0 5.0 5.0 2.0 2.0 2.0 2.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
24. 24. 25. 25. 26. 26. 27. 27. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
DEAL::Checking DGQ1 in 3d:
DEAL::Checking DGQ2 in 1d:
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 6.0 8.0 8.0 2.0 2.0 2.0 2.0
+0
/* This file was generated by the deal.II library.
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
54. 54. 56. 56. 60. 60. 62. 62. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
DEAL::Checking DGQ2 in 3d:
DEAL::Checking Nedelec1 in 2d:
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
3
node_data_0
node_data_1
64. 64. 64. 64. 84. 84. 84. 84. 72. 80. 72. 80. 72. 80. 72. 80. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0
+0
DEAL::Checking Nedelec1 in 3d:
[1.00 color White]
} } }
+0
mesh {
triangle {
endgmv
# This file was generated by the deal.II library.
+0
#
# For a description of the Tecplot format see the Tecplot documentation.
end
# This file was generated by the deal.II library.
+0
#
# For a description of the UCD format see the AVS Developer's guide.
[1.00 color White]
} } }
+0
mesh {
triangle {
end
# This file was generated by the deal.II library.
+0
#
# For a description of the UCD format see the AVS Developer's guide.
[1.00 color White]
} } }
+0
mesh {
triangle {
end
# This file was generated by the deal.II library.
+0
#
# For a description of the UCD format see the AVS Developer's guide.
[1.00 color White]
} } }
+0
mesh {
triangle {
end
# This file was generated by the deal.II library.
+0
#
# For a description of the UCD format see the AVS Developer's guide.
[1.00 color White]
} } }
+0
mesh {
triangle {
end
# This file was generated by the deal.II library.
+0
#
# For a description of the UCD format see the AVS Developer's guide.
endgmv
# This file was generated by the deal.II library.
+0
#
# For a description of the Tecplot format see the Tecplot documentation.
0.25000 -6.1232e-17 0.25000 48.000 76.000 6.0000
0.25000 -6.1232e-17 0.50000 80.000 76.000 6.0000
+0
DEAL::Checking Nedelec1 in 3d:
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
3 3
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
3
node_data_0
node_data_1
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 0.0 6.0 0.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
8.0 0.0 8.0 0.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
10. 0.0 10. 0.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 4.0 4.0 4.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
8.0 10. 8.0 10. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
12. 16. 12. 16. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
6.0 0.0 6.0 0.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
8.0 0.0 8.0 0.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
10. 0.0 10. 0.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
4.0 4.0 4.0 4.0 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
8.0 10. 8.0 10. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.
2 2
[deal.II intermediate format graphics data]
[written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
2
node_data
cell_data
12. 16. 12. 16. 6.0 6.0 6.0 6.0
+0
/* This file was generated by the deal.II library.