//
// ---------------------------------------------------------------------
+#ifndef dealii__newton_templates_h
+#define dealii__newton_templates_h
+
#include <deal.II/algorithms/newton.h>
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__operator_templates_h
+#define dealii__operator_templates_h
+
#include <deal.II/algorithms/operator.h>
#include <deal.II/base/logstream.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__theta_timestepping_templates_h
+#define dealii__theta_timestepping_templates_h
+
#include <deal.II/algorithms/theta_timestepping.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif
-#include <deal.II/base/polynomial.h>
-#include <fstream>
-#include <iostream>
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2013 - 2016 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
#ifndef dealii__polynomials_bernstein_h
#define dealii__polynomials_bernstein_h
+#include <deal.II/base/polynomial.h>
+#include <fstream>
+#include <iostream>
+
+
DEAL_II_NAMESPACE_OPEN
/**
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_array_h
+#define dealii__std_cxx1x_array_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/array.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_bind_h
+#define dealii__std_cxx1x_bind_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/bind.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_condition_variable_h
+#define dealii__std_cxx1x_condition_variable_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/condition_variable.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_function_h
+#define dealii__std_cxx1x_function_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/function.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_mutex_h
+#define dealii__std_cxx1x_mutex_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/mutex.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_shared_ptr_h
+#define dealii__std_cxx1x_shared_ptr_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/shared_ptr.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_thread_h
+#define dealii__std_cxx1x_thread_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/thread.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_tuple_h
+#define dealii__std_cxx1x_tuple_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/tuple.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 by the deal.II authors
+// Copyright (C) 2014-2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__std_cxx1x_type_traits_h
+#define dealii__std_cxx1x_type_traits_h
+
// this file is deprecated. simply include the one we use now
#include "../std_cxx11/type_traits.h"
DEAL_II_NAMESPACE_OPEN
namespace std_cxx1x = std_cxx11;
DEAL_II_NAMESPACE_CLOSE
+
+#endif
#ifndef dealii__tensor_base_h
#define dealii__tensor_base_h
#warning This file is deprecated. Use <deal.II/base/tensor.h> instead.
-#endif
# include <deal.II/base/tensor.h>
+
+#endif
//
// ---------------------------------------------------------------------
+#ifndef dealii__fe_dg_vector_templates_h
+#define dealii__fe_dg_vector_templates_h
+
#include <deal.II/fe/fe_dg_vector.h>
#include <deal.II/fe/fe_tools.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif
//
// ---------------------------------------------------------------------
+#ifndef dealii__fe_poly_templates_h
+#define dealii__fe_poly_templates_h
+
#include <deal.II/base/qprojector.h>
#include <deal.II/base/polynomial_space.h>
DEAL_II_NAMESPACE_CLOSE
+
+#endif
//
// ---------------------------------------------------------------------
+#ifndef dealii__fe_poly_face_templates_h
+#define dealii__fe_poly_face_templates_h
+
#include <deal.II/base/qprojector.h>
#include <deal.II/base/polynomial_space.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2011 - 2015 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__matrix_free_dof_info_templates_h
+#define dealii__matrix_free_dof_info_templates_h
+
#include <deal.II/base/memory_consumption.h>
#include <deal.II/base/multithread_info.h>
} // end of namespace internal
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2011 - 2015 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__matrix_free_mapping_info_templates_h
+#define dealii__matrix_free_mapping_info_templates_h
#include <deal.II/base/utilities.h>
#include <deal.II/base/memory_consumption.h>
} // end of namespace MatrixFreeFunctions
} // end of namespace internal
-
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2011 - 2015 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__matrix_free_templates_h
+#define dealii__matrix_free_templates_h
+
#include <deal.II/base/utilities.h>
#include <deal.II/base/memory_consumption.h>
DEAL_II_NAMESPACE_CLOSE
+
+#endif
//
// ---------------------------------------------------------------------
+#ifndef dealii__matrix_free_shape_info_templates_h
+#define dealii__matrix_free_shape_info_templates_h
+
#include <deal.II/base/utilities.h>
#include <deal.II/base/memory_consumption.h>
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2014 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__dof_info_templates_h
+#define dealii__dof_info_templates_h
+
+
#include <deal.II/meshworker/dof_info.h>
#include <deal.II/base/quadrature_lib.h>
DEAL_II_NAMESPACE_CLOSE
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__integration_info_templates_h
+#define dealii__integration_info_templates_h
+
+
#include <deal.II/meshworker/dof_info.h>
#include <deal.II/meshworker/integration_info.h>
#include <deal.II/base/quadrature_lib.h>
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__vector_selector_templates_h
+#define dealii__vector_selector_templates_h
+
#include <deal.II/meshworker/vector_selector.h>
#include <deal.II/base/vector_slice.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
//
// ---------------------------------------------------------------------
+#ifndef dealii__dof_output_operator_templates_h
+#define dealii__dof_output_operator_templates_h
+
#include <deal.II/numerics/dof_output_operator.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif
//
// ---------------------------------------------------------------------
+#ifndef dealii__error_estimator_templates_h
+#define dealii__error_estimator_templates_h
+
#include <deal.II/base/numbers.h>
#include <deal.II/base/thread_management.h>
#include <deal.II/base/quadrature.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif
//
// ---------------------------------------------------------------------
+#ifndef dealii__fe_field_function_templates_h
+#define dealii__fe_field_function_templates_h
+
#include <deal.II/base/utilities.h>
#include <deal.II/base/logstream.h>
}
DEAL_II_NAMESPACE_CLOSE
+
+#endif