From: kanschat Date: Mon, 18 Mar 2013 14:56:33 +0000 (+0000) Subject: support long double X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=de2a27d7dae67ea44d2c0dd17ad4e0efe8a1cef8;p=dealii-svn.git support long double git-svn-id: https://svn.dealii.org/trunk@28931 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/integrators/divergence.h b/deal.II/include/deal.II/integrators/divergence.h index 56b6baff08..8982d4a7ed 100644 --- a/deal.II/include/deal.II/integrators/divergence.h +++ b/deal.II/include/deal.II/integrators/divergence.h @@ -121,9 +121,9 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2011 */ - template + template void cell_residual( - Vector &result, + Vector &result, const FEValuesBase &fetest, const VectorSlice > > > &input, const double factor = 1.) @@ -201,9 +201,9 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2011 */ - template + template void gradient_residual( - Vector &result, + Vector &result, const FEValuesBase &fetest, const std::vector > &input, const double factor = 1.) @@ -273,10 +273,10 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2011 */ - template + template void u_dot_n_residual ( - Vector &result, + Vector &result, const FEValuesBase &fe, const FEValuesBase &fetest, const VectorSlice > > &data, diff --git a/deal.II/include/deal.II/integrators/elasticity.h b/deal.II/include/deal.II/integrators/elasticity.h index 8fe0766f8b..39c6220744 100644 --- a/deal.II/include/deal.II/integrators/elasticity.h +++ b/deal.II/include/deal.II/integrators/elasticity.h @@ -75,10 +75,10 @@ namespace LocalIntegrators * - \int_Z \varepsilon(u): \varepsilon(v) \,dx * \f] */ - template + template inline void cell_residual ( - Vector &result, + Vector &result, const FEValuesBase &fe, const VectorSlice > > > &input, double factor = 1.) @@ -167,9 +167,9 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2013 */ - template + template void nitsche_residual ( - Vector &result, + Vector &result, const FEValuesBase &fe, const VectorSlice > > &input, const VectorSlice > > > &Dinput, @@ -292,11 +292,11 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2013 */ - template + template void ip_residual( - Vector &result1, - Vector &result2, + Vector &result1, + Vector &result2, const FEValuesBase &fe1, const FEValuesBase &fe2, const VectorSlice > > &input1, diff --git a/deal.II/include/deal.II/integrators/l2.h b/deal.II/include/deal.II/integrators/l2.h index 9f5a304f8b..a6b6536639 100644 --- a/deal.II/include/deal.II/integrators/l2.h +++ b/deal.II/include/deal.II/integrators/l2.h @@ -80,9 +80,9 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2008, 2009, 2010 */ - template + template void L2 ( - Vector &result, + Vector &result, const FEValuesBase &fe, const std::vector &input, const double factor = 1.) @@ -109,9 +109,9 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2008, 2009, 2010 */ - template + template void L2 ( - Vector &result, + Vector &result, const FEValuesBase &fe, const VectorSlice > > &input, const double factor = 1.) diff --git a/deal.II/include/deal.II/integrators/laplace.h b/deal.II/include/deal.II/integrators/laplace.h index 7a0c003eba..272e8d2c9d 100644 --- a/deal.II/include/deal.II/integrators/laplace.h +++ b/deal.II/include/deal.II/integrators/laplace.h @@ -486,10 +486,10 @@ namespace LocalIntegrators * @author Guido Kanschat * @date 2010 */ - template + template double compute_penalty( - const MeshWorker::DoFInfo &dinfo1, - const MeshWorker::DoFInfo &dinfo2, + const MeshWorker::DoFInfo &dinfo1, + const MeshWorker::DoFInfo &dinfo2, unsigned int deg1, unsigned int deg2) { diff --git a/deal.II/include/deal.II/meshworker/dof_info.h b/deal.II/include/deal.II/meshworker/dof_info.h index 46116bd4e2..cc12fedd04 100644 --- a/deal.II/include/deal.II/meshworker/dof_info.h +++ b/deal.II/include/deal.II/meshworker/dof_info.h @@ -117,8 +117,7 @@ namespace MeshWorker * pointer empty, but setting * the #aux_local_indices. */ - template - DoFInfo (const DH &dof_handler); + DoFInfo (const DoFHandler& dof_handler); /** * Set the current cell and @@ -281,8 +280,7 @@ namespace MeshWorker //----------------------------------------------------------------------// template - template - DoFInfo::DoFInfo(const DH &dof_handler) + DoFInfo::DoFInfo(const DoFHandler &dof_handler) { std::vector aux(1); aux[0] = dof_handler.get_fe().dofs_per_cell; diff --git a/deal.II/include/deal.II/meshworker/integration_info.h b/deal.II/include/deal.II/meshworker/integration_info.h index a57459f2db..dbea00f0e1 100644 --- a/deal.II/include/deal.II/meshworker/integration_info.h +++ b/deal.II/include/deal.II/meshworker/integration_info.h @@ -1,7 +1,7 @@ //--------------------------------------------------------------------------- // $Id$ // -// Copyright (C) 2006, 2007, 2008, 2009, 2010, 2011, 2012 by the deal.II authors +// Copyright (C) 2006, 2007, 2008, 2009, 2010, 2011, 2012, 2013 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -220,7 +220,8 @@ namespace MeshWorker * Reinitialize internal data * structures for use on a cell. */ - void reinit(const DoFInfo &i); + template + void reinit(const DoFInfo &i); /** * Use the finite element @@ -887,8 +888,9 @@ namespace MeshWorker template + template inline void - IntegrationInfo::reinit(const DoFInfo &info) + IntegrationInfo::reinit(const DoFInfo &info) { for (unsigned int i=0; i + template inline void - IntegrationInfo<1,1>::reinit(const DoFInfo<1,1> &info) + IntegrationInfo<1,1>::reinit(const DoFInfo<1,1,number> &info) { const int dim = 1; const int spacedim = 1; @@ -954,8 +957,9 @@ namespace MeshWorker template <> + template inline void - IntegrationInfo<1,2>::reinit(const DoFInfo<1,2> &info) + IntegrationInfo<1,2>::reinit(const DoFInfo<1,2,number> &info) { const int dim = 1; const int spacedim = 2;