Alamo
HeatConduction.H
Go to the documentation of this file.
1//
2// This implements a basic heat conduction method in Alamo.
3// The partial differential equation to be solved is
4//
5// .. math::
6//
7// \frac{\partial T}{\partial t} = \alpha\,\Delta T
8//
9// where :math:`T` is temperature, :math:`t` is time, and :math:`alpha`
10// is the thermal diffusivity.
11// Integration is performed explicitly in time using forward Euler, and
12// differentiation is performed using the finite difference method.
13//
14
15#ifndef INTEGRATOR_HEATCONDUCTION_H // Include guards
16#define INTEGRATOR_HEATCONDUCTION_H //
17
18// AMReX Includes
19#include "AMReX_Array4.H"
20#include "AMReX_GpuComplex.H"
21#include "AMReX_MFIter.H"
22#include <AMReX.H>
23#include <AMReX_ParallelDescriptor.H>
24#include <AMReX_ParmParse.H>
25#include <AMReX_TimeIntegrator.H>
26#ifdef ALAMO_FFT
27#include <AMReX_FFT.H>
28#endif
29
30// Alamo Includes
31#include "Set/Base.H"
32#include "Integrator.H"
33#include "IO/ParmParse.H"
35#include "BC/Constant.H"
36#include "BC/Expression.H"
37#include "IC/IC.H"
38#include "IC/Sphere.H"
39#include "IC/Constant.H"
40#include "IC/Expression.H"
41#include "Numeric/Stencil.H"
42
43namespace Integrator
44{
45class HeatConduction : virtual public Integrator
46{
47public:
48 static constexpr const char* name = "heatconduction";
49
50
51 // Empty constructor
52 HeatConduction(int a_nghost = 2) :
53 Integrator(),
54 number_of_ghost_cells(a_nghost)
55 {}
56
57 // Constructor that triggers parse
59 {
60 Parse(*this, pp);
61 }
62
64 {
65 delete ic;
66 delete bc;
67 }
68
69 // The Parse function initializes the HeatConduction object using
70 // a parser, pp.
71 // Note that this is a static function, which means it does not have
72 // direct access to member variables. Instead, it initializes the variables
73 // inside the argument, "value", and so all references to member items are
74 // prefixed by "value."
75 static void Parse(HeatConduction& value, IO::ParmParse& pp)
76 {
77 // Diffusion coefficient :math:`\alpha`.
78 // *This is an example of a required input variable -
79 // - program will terminate unless it is provided.*
80 pp.query_required( "heat.alpha", value.alpha,
82
83 // Criterion for mesh refinement.
84 // *This is an example of a default input variable.
85 // The default value is provided here, not in the
86 // definition of the variable.*
87 pp.query_default( "heat.refinement_threshold", value.refinement_threshold, "0.01_K",
89
90 // Initial condition type.
91 pp.select_default<IC::Constant,IC::Sphere,IC::Expression>( "ic",value.ic,value.geom,
93
94 // Select BC object for temperature
95 pp.select_default<BC::Constant,BC::Expression>( "bc.temp",value.bc,1,
97
98 // Select between using a realspace solve or the spectral method
99 pp.query_validate("method",value.method,{"realspace","spectral"});
100
101 // Register the temperature and old temperature fields.
102 // temp_mf and temp_old_mf are defined near the bottom of this Header file.
103 value.RegisterNewFab( value.temp_mf, value.bc, value.number_of_components,
104 value.number_of_ghost_cells, "Temp", true);
105 if (value.method == "realspace")
106 {
107 value.RegisterNewFab( value.temp_old_mf, value.bc, value.number_of_components,
108 value.number_of_ghost_cells, "Temp_old", false);
109 }
110 }
111
112protected:
113
114 // Use the ic object to initialize the temperature field
115 void Initialize(int lev)
116 {
117 ic->Initialize(lev, temp_mf);
118 if (method == "realspace") ic->Initialize(lev, temp_old_mf);
119 }
120
121 // Integrate the heat equation
122 void Advance(int lev, Set::Scalar time, Set::Scalar dt)
123 {
124 // If we are solving using the spectral method, go there instead.
125 if (method == "spectral")
126 {
127 AdvanceSpectral(lev,time,dt);
128 return;
129 }
130
131 // Swap the old temp fab and the new temp fab so we use
132 // the new one.
133 std::swap(*temp_mf[lev], *temp_old_mf[lev]);
134
135 // Create the time integrator object
136 amrex::TimeIntegrator timeintegrator(*temp_old_mf[lev], time);
137
138 // Calculate the "RHS" of the function.
139 // If using forward Euler, the RHS would be
140 // T_new = T_old + dt * RHS
141 timeintegrator.set_rhs([&](amrex::MultiFab & rhs_mf, amrex::MultiFab & temp_mf, const Set::Scalar /*time*/)
142 {
143 // Get the cell size corresponding to this level
144 const Set::Scalar* DX = geom[lev].CellSize();
145
146 // Iterate over all of the patches on this level
147 for (amrex::MFIter mfi(temp_mf, amrex::TilingIfNotGPU()); mfi.isValid(); ++mfi)
148 {
149 // Get the box (index dimensions) for this patch
150 const amrex::Box &bx = mfi.tilebox();
151
152 // Get an array-accessible handle to the data on this patch.
153 Set::Patch<const Set::Scalar> temp = temp_mf.array(mfi);
154 Set::Patch<Set::Scalar> rhs = rhs_mf.array(mfi);
155
156 // Iterate over the grid on this patch
157 amrex::ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k)
158 {
159 // Do the physics!
160 // Note that Numeric::Laplacian is an inlined function so there is no overhead.
161 // You can calculate the derivatives yourself if you want.
162 rhs(i, j, k) = alpha * Numeric::Laplacian(temp, i, j, k, 0, DX);
163 });
164 }
165 });
166
167 // We must update the boundaries here and apply boundary conditions
168 timeintegrator.set_post_stage_action([&](amrex::MultiFab & stage_mf, Set::Scalar time)
169 {
170 bc->FillBoundary(stage_mf,0,1,time,0);
171 stage_mf.FillBoundary(true);
172 });
173
174 // Do the update
175 timeintegrator.advance(*temp_old_mf[lev], *temp_mf[lev], time, dt);
176 }
177
178
179#ifdef ALAMO_FFT
180 void
181 AdvanceSpectral(int lev, Set::Scalar /*time*/, Set::Scalar dt)
182 {
183 Util::Assert(INFO,TEST(lev == 0), "Only single level currently supported");
184
185 amrex::Box const & domain = this->geom[lev].Domain();
186
187 amrex::FFT::R2C my_fft(this->geom[lev].Domain());
188 auto const& [cba, cdm] = my_fft.getSpectralDataLayout();
189 amrex::FabArray<amrex::BaseFab<amrex::GpuComplex<Set::Scalar> > > Temp_hat(cba, cdm, 1, 0);
190 my_fft.forward(*temp_mf[lev], Temp_hat);
191
192 const Set::Scalar* DX = geom[lev].CellSize();
193
195 AMREX_D_DECL(
196 pi_Lx = 2.0 * Set::Constant::Pi / geom[lev].Domain().length(0) / DX[0],
197 pi_Ly = 2.0 * Set::Constant::Pi / geom[lev].Domain().length(1) / DX[1],
198 pi_Lz = 2.0 * Set::Constant::Pi / geom[lev].Domain().length(2) / DX[2]);
199
200 Set::Scalar scaling = 1.0 / geom[lev].Domain().d_numPts();
201
202 for (amrex::MFIter mfi(Temp_hat, amrex::TilingIfNotGPU()); mfi.isValid(); ++mfi)
203 {
204 const amrex::Box &bx = mfi.tilebox();
205 amrex::Array4<amrex::GpuComplex<Set::Scalar>> const & T_hat = Temp_hat.array(mfi);
206 amrex::ParallelFor(bx, [=] AMREX_GPU_DEVICE(int m, int n, int p) {
207
208 AMREX_D_TERM(
209 Set::Scalar k1 = m * pi_Lx;,
210 Set::Scalar k2 = (n < domain.length(1)/2 ? n * pi_Ly : (n - domain.length(1)) * pi_Ly);,
211 Set::Scalar k3 = (p < domain.length(2)/2 ? p * pi_Lz : (p - domain.length(2)) * pi_Lz););
212
213 Set::Scalar lap = AMREX_D_TERM(k1 * k1, + k2 * k2, + k3*k3);
214
215 Set::Scalar factor = exp( - alpha * dt * lap);
216 T_hat(m,n,p) *= factor*scaling;
217 });
218 }
219
220 my_fft.backward(Temp_hat, *temp_mf[lev]);
221 }
222#else
223 void
225 {
226 Util::Abort(INFO,"Alamo must be configured with --fft");
227 }
228#endif
229
230
231 // Tag cells for mesh refinement based on temperature gradient
232 void TagCellsForRefinement(int lev, amrex::TagBoxArray& a_tags, Set::Scalar /*time*/, int /*ngrow*/)
233 {
234 if (method=="spectral") return;
235
236 // Get cell dimensions as done above.
237 const Set::Scalar* DX = geom[lev].CellSize();
238 // Calculate the diagonal.
239 Set::Scalar dr = sqrt(AMREX_D_TERM(DX[0] * DX[0], +DX[1] * DX[1], +DX[2] * DX[2]));
240
241 // Iterate over the patches on this level
242 for (amrex::MFIter mfi(*temp_mf[lev], amrex::TilingIfNotGPU()); mfi.isValid(); ++mfi)
243 {
244 // Get the box and handles as done above.
245 const amrex::Box& bx = mfi.tilebox();
246 amrex::Array4<char> const& tags = a_tags.array(mfi);
247 amrex::Array4<Set::Scalar> const& temp = (*temp_mf[lev]).array(mfi);
248
249 // Iterate over the grid as done above.
250 amrex::ParallelFor(bx, [=] AMREX_GPU_DEVICE(int i, int j, int k)
251 {
252 // Calculate the temperature gradient.
253 Set::Vector grad = Numeric::Gradient(temp, i, j, k, 0, DX);
254
255 // Is the gradient * cell_size too big? If so, then
256 // mark this cell as needing refinement.
257 if (grad.lpNorm<2>() * dr > refinement_threshold)
258 tags(i, j, k) = amrex::TagBox::SET;
259 });
260 }
261 }
262
263protected:
264 Set::Field<Set::Scalar> temp_mf; // Temperature field variable (current timestep)
265 Set::Field<Set::Scalar> temp_old_mf; // Temperature field variable (previous timestep)
266
267 std::string method; // determine whether to use realspace or spectral method
268
269private:
270
271 //
272 // Definition of parameters set only at instantiation by
273 // constructors.
274 //
275 const int number_of_components = 1; // Number of components
276 const int number_of_ghost_cells = 2; // Number of ghost cells
277
278 //
279 // Definition of user-determined variables.
280 //
281 // Instantiate all variables to NAN if possible.
282 // Default values may be set in Parse using query_default.
283 //
284
285 Set::Scalar alpha = NAN; // Thermal diffusivity
286 Set::Scalar refinement_threshold = NAN ; // Criterion for cell refinement
287
288 //
289 // Definition of user-determined pointer variables.
290 //
291 // These should be set to nullptr. Make sure that they are deleted
292 // in the ~HeatConduction destructor.
293 //
294
295 IC::IC<Set::Scalar>* ic = nullptr; // Object used to initialize temperature field
296 BC::BC<Set::Scalar>* bc = nullptr; // Object used to update temp field boundary ghost cells
297};
298} // namespace Integrator
299#endif
#define TEST(x)
Definition Util.H:22
#define INFO
Definition Util.H:21
Definition BC.H:43
Pure abstract IC object from which all other IC objects inherit.
Definition IC.H:23
int query_required(std::string name, T &value)
Definition ParmParse.H:249
void select_default(std::string name, PTRTYPE *&ic_eta, Args &&... args)
Definition ParmParse.H:1095
int query_default(std::string name, T &value, T defaultvalue)
Definition ParmParse.H:293
int query_validate(std::string name, int &value, std::vector< int > possibleintvals)
Definition ParmParse.H:336
Set::Field< Set::Scalar > temp_mf
static void Parse(HeatConduction &value, IO::ParmParse &pp)
BC::BC< Set::Scalar > * bc
HeatConduction(int a_nghost=2)
void Advance(int lev, Set::Scalar time, Set::Scalar dt)
IC::IC< Set::Scalar > * ic
HeatConduction(IO::ParmParse &pp)
void AdvanceSpectral(int, Set::Scalar, Set::Scalar)
Set::Field< Set::Scalar > temp_old_mf
void TagCellsForRefinement(int lev, amrex::TagBoxArray &a_tags, Set::Scalar, int)
static constexpr const char * name
Collection of numerical integrator objects.
Definition AllenCahn.H:42
AMREX_FORCE_INLINE Set::Scalar Laplacian(const amrex::Array4< const Set::Scalar > &f, const int &i, const int &j, const int &k, const int &m, const Set::Scalar dx[AMREX_SPACEDIM], std::array< StencilType, AMREX_SPACEDIM > &stencil=DefaultType)
Definition Stencil.H:546
AMREX_FORCE_INLINE Set::Vector Gradient(const amrex::Array4< const Set::Scalar > &f, const int &i, const int &j, const int &k, const int &m, const Set::Scalar dx[AMREX_SPACEDIM], std::array< StencilType, AMREX_SPACEDIM > stencil=DefaultType)
Definition Stencil.H:672
const Set::Scalar Pi
Definition Set.cpp:13
amrex::Real Scalar
Definition Base.H:18
Eigen::Matrix< amrex::Real, AMREX_SPACEDIM, 1 > Vector
Definition Base.H:19
void Abort(const char *msg)
Definition Util.cpp:243
AMREX_FORCE_INLINE void Assert(std::string file, std::string func, int line, std::string smt, bool pass, Args const &... args)
Definition Util.H:55
static Unit ThermalDiffusivity()
Definition Unit.H:227
static Unit Temperature()
Definition Unit.H:201