+++ /dev/null
-//---------------------------------------------------------------
-// $Id$
-// Version: $Name$
-//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002 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.
-//
-//---------------------------------------------------------------
-#ifndef __deal2__fe_lib_dg_h
-#define __deal2__fe_lib_dg_h
-
-
-#include <base/config.h>
-#include<fe/fe_dgq.h>
-
-
-
-
-
-/**
- * This class is an abbreviation for the @ref{FE_DGQ} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_DGQ}) is fixed to zero, i.e. piecewise constant elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_DGQ} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEDG_Q0 : public FE_DGQ<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEDG_Q0(): FE_DGQ<dim>(0) {};
-};
-
-
-/**
- * This class is an abbreviation for the @ref{FE_DGQ} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_DGQ}) is fixed to one, i.e. piecewise @p{d}-linear elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_DGQ} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEDG_Q1 : public FE_DGQ<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEDG_Q1(): FE_DGQ<dim>(1) {};
-};
-
-
-/**
- * This class is an abbreviation for the @ref{FE_DGQ} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_DGQ}) is fixed to two, i.e. piecewise @p{d}-quadratic elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_DGQ} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEDG_Q2 : public FE_DGQ<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEDG_Q2(): FE_DGQ<dim>(2) {};
-};
-
-
-/**
- * This class is an abbreviation for the @ref{FE_DGQ} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_DGQ}) is fixed to three, i.e. piecewise @p{d}-cubic elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_DGQ} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEDG_Q3 : public FE_DGQ<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEDG_Q3(): FE_DGQ<dim>(3) {};
-};
-
-
-/**
- * This class is an abbreviation for the @ref{FE_DGQ} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_DGQ}) is fixed to four, i.e. piecewise @p{d}-quartic elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_DGQ} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEDG_Q4 : public FE_DGQ<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEDG_Q4(): FE_DGQ<dim>(4) {};
-};
-
-
-#endif
+++ /dev/null
-//---------------------------------------------------------------
-// $Id$
-// Version: $Name$
-//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002 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.
-//
-//---------------------------------------------------------------
-#ifndef __deal2__fe_lib_lagrange_h
-#define __deal2__fe_lib_lagrange_h
-
-
-#include <base/config.h>
-#include<fe/fe_q.h>
-
-
-
-
-/**
- * This class is an abbreviation for the @ref{FE_Q} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_Q}) is fixed to one, i.e. @p{d}-linear elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_Q} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEQ1 : public FE_Q<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEQ1(): FE_Q<dim>(1) {};
-};
-
-
-/**
- * This class is an abbreviation for the @ref{FE_Q} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_Q}) is fixed to two, i.e. @p{d}-quadratic elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_Q} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEQ2 : public FE_Q<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEQ2(): FE_Q<dim>(2) {};
-};
-
-
-/**
- * This class is an abbreviation for the @ref{FE_Q} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_Q}) is fixed to three, i.e. @p{d}-cubic elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_Q} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEQ3 : public FE_Q<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEQ3(): FE_Q<dim>(3) {};
-};
-
-
-/**
- * This class is an abbreviation for the @ref{FE_Q} class, where the
- * polynomial degree (which is passed through the constructor of
- * @ref{FE_Q}) is fixed to four, i.e. @p{d}-quartic elements.
- *
- * This class is only here for backward compatibility and will go away
- * someday. Use the @ref{FE_Q} class instead.
- *
- * @author Wolfgang Bangerth, Ralf Hartmann, 2001
- */
-template<int dim>
-class FEQ4 : public FE_Q<dim>
-{
- public:
- /**
- * Constructor. Simply pass
- * correct polynomial degree to
- * constructor of base class.
- */
- FEQ4(): FE_Q<dim>(4) {};
-};
-
-
-#endif
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/exceptions.h>
#include <base/point.h>
#include <lac/vector.h>
-#include <fe/fe_lib.lagrange.h>
-#include <fe/fe_lib.dg.h>
#include <fe/fe_system.h>
#include <fe/fe_tools.h>
#include <grid/tria.h>
// $Id$
// Version: $Name$
//
-// std::copyright (C) 1998, 1999, 2000, 2001 by Wolfgang Bangerth
+// std::copyright (C) 1998, 1999, 2000, 2001, 2002 by Wolfgang Bangerth
//
// This file is subject to QPL and may not be distributed
// without std::copyright and license information. Please refer
#include <grid/forward_declarations.h>
#include <lac/vector.h>
+#include <fe/fe_q.h>
#include <fstream>
#include <string>
#include <vector>
*/
template <int dim>
struct FEHelper {
- static const FEQ1<dim> fe_linear;
- static const FEQ2<dim> fe_quadratic_sub;
+ static const FE_Q<dim> fe_linear;
+ static const FE_Q<dim> fe_quadratic_sub;
#if 2 < 3
- static const FEQ3<dim> fe_cubic_sub;
- static const FEQ4<dim> fe_quartic_sub;
+ static const FE_Q<dim> fe_cubic_sub;
+ static const FE_Q<dim> fe_quartic_sub;
#endif
static const QGauss2<dim> q_gauss_2;
static const Quadrature<dim-1> & get_quadrature_face (const std::string &name);
};
+template<int dim> const FE_Q<dim> FEHelper<dim>::fe_linear(1);
+template<int dim> const FE_Q<dim> FEHelper<dim>::fe_quadratic_sub(2);
+#if 2 < 3
+template<int dim> const FE_Q<dim> FEHelper<dim>::fe_cubic_sub(3);
+template<int dim> const FE_Q<dim> FEHelper<dim>::fe_quartic_sub(4);
+#endif
template <int dim> class DualFunctional;
template <int dim> class EvaluationBase;
};
-
-
-#include <fe/fe_lib.lagrange.h>
#include <fe/mapping_q1.h>
#include <base/quadrature_lib.h>
-const FEQ1<2> FEHelper<2>::fe_linear;
-const FEQ2<2> FEHelper<2>::fe_quadratic_sub;
+const FE_Q<2> FEHelper<2>::fe_linear(1);
+const FE_Q<2> FEHelper<2>::fe_quadratic_sub(2);
#if 2 < 3
-const FEQ3<2> FEHelper<2>::fe_cubic_sub;
-const FEQ4<2> FEHelper<2>::fe_quartic_sub;
+const FE_Q<2> FEHelper<2>::fe_cubic_sub(3);
+const FE_Q<2> FEHelper<2>::fe_quartic_sub(4);
#endif
const QGauss2<2> FEHelper<2>::q_gauss_2;
// $Id$
-// Copyright (C) 2001 Michael Stadler, Wolfgang Bangerth
+// Copyright (C) 2001, 2002 Michael Stadler, Wolfgang Bangerth
//
#include <base/quadrature_lib.h>
#include <fe/fe_system.h>
#include <fe/mapping_q1_eulerian.h>
#include <fe/fe_values.h>
-#include <fe/fe_lib.lagrange.h>
#include <vector>
#include <fstream>
#include <string>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <grid/tria_iterator.h>
#include <dofs/dof_accessor.h>
#include <grid/grid_generator.h>
-#include <fe/fe_lib.lagrange.h>
-#include <fe/fe_lib.dg.h>
#include <fe/fe_values.h>
#include <multigrid/multigrid.h>
#include <multigrid/mg_dof_handler.h>