REMORA
Regional Modeling of Oceans Refined Adaptively
Loading...
Searching...
No Matches
REMORA_Plotfile.cpp
Go to the documentation of this file.
1#include <REMORA.H>
2#include "AMReX_Interp_3D_C.H"
3#include "AMReX_PlotFileUtil.H"
4
5using namespace amrex;
6
7PhysBCFunctNoOp null_bc_for_fill;
8
9template<typename V, typename T>
10bool containerHasElement(const V& iterable, const T& query) {
11 return std::find(iterable.begin(), iterable.end(), query) != iterable.end();
12}
13
14/**
15 * @param pp_plot_var_names list of variable names to plot read in from parameter file
16 */
17void
18REMORA::setPlotVariables (const std::string& pp_plot_var_names)
19{
20 ParmParse pp(pp_prefix);
21
22 if (pp.contains(pp_plot_var_names.c_str()))
23 {
24 std::string nm;
25
26 int nPltVars = pp.countval(pp_plot_var_names.c_str());
27
28 for (int i = 0; i < nPltVars; i++)
29 {
30 pp.get(pp_plot_var_names.c_str(), nm, i);
31
32 // Add the named variable to our list of plot variables
33 // if it is not already in the list
35 plot_var_names.push_back(nm);
36 }
37 }
38 } else {
39 //
40 // The default is to add none of the variables to the list
41 //
42 plot_var_names.clear();
43 }
44
45 // Get state variables in the same order as we define them,
46 // since they may be in any order in the input list
47 Vector<std::string> tmp_plot_names;
48
49 for (int i = 0; i < NCONS; ++i) {
51 tmp_plot_names.push_back(cons_names[i]);
52 }
53 }
54 // Check for velocity since it's not in cons_names
55 // If we are asked for any velocity component, we will need them all
56 if (containerHasElement(plot_var_names, "x_velocity") ||
57 containerHasElement(plot_var_names, "y_velocity") ||
58 containerHasElement(plot_var_names, "z_velocity")) {
59 tmp_plot_names.push_back("x_velocity");
60 tmp_plot_names.push_back("y_velocity");
61 tmp_plot_names.push_back("z_velocity");
62 }
63
64 // If we are asked for any location component, we will provide them all
68 tmp_plot_names.push_back("x_cc");
69 tmp_plot_names.push_back("y_cc");
70 tmp_plot_names.push_back("z_cc");
71 }
72
73 for (int i = 0; i < derived_names.size(); ++i) {
75 tmp_plot_names.push_back(derived_names[i]);
76 } // if
77 } // i
78
79#ifdef REMORA_USE_PARTICLES
80 const auto& particles_namelist( particleData.getNamesUnalloc() );
81 for (auto it = particles_namelist.cbegin(); it != particles_namelist.cend(); ++it) {
82 std::string tmp( (*it)+"_count" );
84 tmp_plot_names.push_back(tmp);
85 }
86 }
87#endif
88
89 // Check to see if we found all the requested variables
90 for (auto plot_name : plot_var_names) {
91 if (!containerHasElement(tmp_plot_names, plot_name)) {
92 Warning("\nWARNING: Requested to plot variable '" + plot_name + "' but it is not available");
93 }
94 }
95 plot_var_names = tmp_plot_names;
96}
97
98/**
99 * @param pp_plot_var_names variables to add to plot list
100 */
101void
102REMORA::appendPlotVariables (const std::string& pp_plot_var_names)
103{
104 ParmParse pp(pp_prefix);
105
106 if (pp.contains(pp_plot_var_names.c_str())) {
107 std::string nm;
108 int nPltVars = pp.countval(pp_plot_var_names.c_str());
109 for (int i = 0; i < nPltVars; i++) {
110 pp.get(pp_plot_var_names.c_str(), nm, i);
111 // Add the named variable to our list of plot variables
112 // if it is not already in the list
114 plot_var_names.push_back(nm);
115 }
116 }
117 }
118
119 Vector<std::string> tmp_plot_names(0);
120#ifdef REMORA_USE_PARTICLES
121 Vector<std::string> particle_mesh_plot_names;
122 particleData.GetMeshPlotVarNames( particle_mesh_plot_names );
123 for (int i = 0; i < particle_mesh_plot_names.size(); i++) {
124 std::string tmp(particle_mesh_plot_names[i]);
126 tmp_plot_names.push_back(tmp);
127 }
128 }
129#endif
130
131 for (int i = 0; i < tmp_plot_names.size(); i++) {
132 plot_var_names.push_back( tmp_plot_names[i] );
133 }
134
135 // Finally, check to see if we found all the requested variables
136 for (const auto& plot_name : plot_var_names) {
137 if (!containerHasElement(plot_var_names, plot_name)) {
138 if (amrex::ParallelDescriptor::IOProcessor()) {
139 Warning("\nWARNING: Requested to plot variable '" + plot_name + "' but it is not available");
140 }
141 }
142 }
143}
144
145// Write plotfile to disk
146void
148{
149 Vector<std::string> varnames;
150 varnames.insert(varnames.end(), plot_var_names.begin(), plot_var_names.end());
151
152 const int ncomp_mf = varnames.size();
153 const auto ngrow_vars = IntVect(NGROW-1,NGROW-1,0);
154
155 if (ncomp_mf == 0) {
156 return;
157 }
158
159 // We fillpatch here because some of the derived quantities require derivatives
160 // which require ghost cells to be filled. Don't fill the boundary, though.
161 for (int lev = 0; lev <= finest_level; ++lev) {
162 FillPatchNoBC(lev, t_new[lev], *cons_new[lev], cons_new, BdyVars::t,0,true,false);
163 FillPatchNoBC(lev, t_new[lev], *xvel_new[lev], xvel_new, BdyVars::u,0,true,false);
164 FillPatchNoBC(lev, t_new[lev], *yvel_new[lev], yvel_new, BdyVars::v,0,true,false);
165 FillPatchNoBC(lev, t_new[lev], *zvel_new[lev], zvel_new, BdyVars::null,0,true,false);
166 }
167
168 Real fill_value = 0.0_rt;
169 for (int lev = 0; lev <= finest_level; ++lev) {
170 mask_arrays_for_write(lev, (Real) fill_value, 0.0_rt);
171 }
172
173 // Array of MultiFabs to hold the plotfile data
174 Vector<MultiFab> mf(finest_level+1);
175 for (int lev = 0; lev <= finest_level; ++lev) {
176 mf[lev].define(grids[lev], dmap[lev], ncomp_mf, ngrow_vars);
177 }
178
179 // Array of MultiFabs for nodal data
180 Vector<MultiFab> mf_nd(finest_level+1);
181 for (int lev = 0; lev <= finest_level; ++lev) {
182 BoxArray nodal_grids(grids[lev]); nodal_grids.surroundingNodes();
183 mf_nd[lev].define(nodal_grids, dmap[lev], AMREX_SPACEDIM, 0);
184 mf_nd[lev].setVal(0.);
185 }
186
187 // Vector of MultiFabs for face-centered velocity
188 Vector<MultiFab> mf_u(finest_level+1);
189 Vector<MultiFab> mf_v(finest_level+1);
190 Vector<MultiFab> mf_w(finest_level+1);
192 for (int lev = 0; lev <= finest_level; ++lev) {
193 BoxArray grid_stag_u(grids[lev]); grid_stag_u.surroundingNodes(0);
194 BoxArray grid_stag_v(grids[lev]); grid_stag_v.surroundingNodes(1);
195 BoxArray grid_stag_w(grids[lev]); grid_stag_w.surroundingNodes(2);
196 mf_u[lev].define(grid_stag_u, dmap[lev], 1, 0);
197 mf_v[lev].define(grid_stag_v, dmap[lev], 1, 0);
198 mf_w[lev].define(grid_stag_w, dmap[lev], 1, 0);
199 MultiFab::Copy(mf_u[lev],*xvel_new[lev],0,0,1,0);
200 MultiFab::Copy(mf_v[lev],*yvel_new[lev],0,0,1,0);
201 MultiFab::Copy(mf_w[lev],*zvel_new[lev],0,0,1,0);
202 }
203 }
204
205 // Array of MultiFabs for cell-centered velocity
206 Vector<MultiFab> mf_cc_vel(finest_level+1);
207
208 if (containerHasElement(plot_var_names, "x_velocity") ||
209 containerHasElement(plot_var_names, "y_velocity") ||
210 containerHasElement(plot_var_names, "z_velocity") ||
211 containerHasElement(plot_var_names, "vorticity") ) {
212
213 for (int lev = 0; lev <= finest_level; ++lev) {
214 mf_cc_vel[lev].define(grids[lev], dmap[lev], AMREX_SPACEDIM, IntVect(1,1,0));
215 mf_cc_vel[lev].setVal(0.0_rt); // zero out velocity in case we have any wall boundaries
216 average_face_to_cellcenter(mf_cc_vel[lev],0,
217 Array<const MultiFab*,3>{xvel_new[lev],yvel_new[lev],zvel_new[lev]});
218 mf_cc_vel[lev].FillBoundary(geom[lev].periodicity());
219 } // lev
220
221 // We need ghost cells if computing vorticity
222 amrex::Interpolater* mapper = &cell_cons_interp;
223 if ( containerHasElement(plot_var_names, "vorticity") ) {
224 for (int lev = 1; lev <= finest_level; ++lev) {
225 Vector<MultiFab*> fmf = {&(mf_cc_vel[lev]), &(mf_cc_vel[lev])};
226 Vector<Real> ftime = {t_new[lev], t_new[lev]};
227 Vector<MultiFab*> cmf = {&mf_cc_vel[lev-1], &mf_cc_vel[lev-1]};
228 Vector<Real> ctime = {t_new[lev], t_new[lev]};
229
230 MultiFab mf_to_fill;
231 amrex::FillPatchTwoLevels(mf_cc_vel[lev], t_new[lev], cmf, ctime, fmf, ftime,
232 0, 0, AMREX_SPACEDIM, geom[lev-1], geom[lev],
233 null_bc_for_fill, 0, null_bc_for_fill, 0, refRatio(lev-1),
234 mapper, domain_bcs_type, 0);
235 } // lev
236 } // if
237 } // if
238
239 for (int lev = 0; lev <= finest_level; ++lev)
240 {
241 int mf_comp = 0;
242
243 // First, copy any of the conserved state variables into the output plotfile
244 AMREX_ALWAYS_ASSERT(cons_names.size() == NCONS);
245 for (int i = 0; i < NCONS; ++i) {
247 if (cons_new[lev]->contains_nan() || cons_new[lev]->contains_inf()) {
248 amrex::Abort("Found while writing output: Cons (salt, temp, or scalar, etc) contains nan or inf");
249 }
250 MultiFab::Copy(mf[lev],*cons_new[lev],i,mf_comp,1,ngrow_vars);
251 mf_comp++;
252 }
253 } // NCONS
254
255 // Next, check for velocities
256 if (containerHasElement(plot_var_names, "x_velocity")) {
257 if (mf_cc_vel[lev].contains_nan(0,1) || mf_cc_vel[lev].contains_inf(0,1)) {
258 amrex::Abort("Found while writing output: u velocity contains nan or inf");
259 }
260 MultiFab::Copy(mf[lev], mf_cc_vel[lev], 0, mf_comp, 1, 0);
261 mf_comp += 1;
262 }
263 if (containerHasElement(plot_var_names, "y_velocity")) {
264 if (mf_cc_vel[lev].contains_nan(1,1) || mf_cc_vel[lev].contains_inf(1,1)) {
265 amrex::Abort("Found while writing output: v velocity contains nan or inf");
266 }
267 MultiFab::Copy(mf[lev], mf_cc_vel[lev], 1, mf_comp, 1, 0);
268 mf_comp += 1;
269 }
270 if (containerHasElement(plot_var_names, "z_velocity")) {
271 if (mf_cc_vel[lev].contains_nan(2,1) || mf_cc_vel[lev].contains_inf(2,1)) {
272 amrex::Abort("Found while writing output: z velocity contains nan or inf");
273 }
274 MultiFab::Copy(mf[lev], mf_cc_vel[lev], 2, mf_comp, 1, 0);
275 mf_comp += 1;
276 }
277
278 // Define standard process for calling the functions in Derive.cpp
279 auto calculate_derived = [&](const std::string& der_name,
280 decltype(derived::remora_dernull)& der_function)
281 {
282 if (containerHasElement(plot_var_names, der_name)) {
283 MultiFab dmf(mf[lev], make_alias, mf_comp, 1);
284#ifdef _OPENMP
285#pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
286#endif
287 for (MFIter mfi(dmf, TilingIfNotGPU()); mfi.isValid(); ++mfi)
288 {
289 const Box& bx = mfi.tilebox();
290 auto& dfab = dmf[mfi];
291
292 if (der_name == "vorticity") {
293 auto const& sfab = mf_cc_vel[lev][mfi];
294 der_function(bx, dfab, 0, 1, sfab, vec_pm[lev]->const_array(mfi), vec_pn[lev]->const_array(mfi), Geom(lev), t_new[0], nullptr, lev);
295 } else {
296 auto const& sfab = (*cons_new[lev])[mfi];
297 der_function(bx, dfab, 0, 1, sfab, vec_pm[lev]->const_array(mfi), vec_pn[lev]->const_array(mfi), Geom(lev), t_new[0], nullptr, lev);
298 }
299 }
300
301 mf_comp++;
302 }
303 };
304
305 // Note: All derived variables must be computed in order of "derived_names" defined in REMORA.H
306 calculate_derived("vorticity", derived::remora_dervort);
307
308 // Fill cell-centered location
309 Real dx = Geom()[lev].CellSizeArray()[0];
310 Real dy = Geom()[lev].CellSizeArray()[1];
311
312 // Next, check for location names -- if we write one we write all
313 if (containerHasElement(plot_var_names, "x_cc") ||
316 {
317 MultiFab dmf(mf[lev], make_alias, mf_comp, AMREX_SPACEDIM);
318#ifdef _OPENMP
319#pragma omp parallel if (Gpu::notInLaunchRegion())
320#endif
321 for (MFIter mfi(dmf, TilingIfNotGPU()); mfi.isValid(); ++mfi) {
322 const Box& bx = mfi.tilebox();
323 const Array4<Real> loc_arr = dmf.array(mfi);
324 const Array4<Real const> zp_arr = vec_z_phys_nd[lev]->const_array(mfi);
325
326 ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) {
327 loc_arr(i,j,k,0) = (i+0.5_rt) * dx;
328 loc_arr(i,j,k,1) = (j+0.5_rt) * dy;
329 loc_arr(i,j,k,2) = 0.125_rt * (zp_arr(i,j ,k ) + zp_arr(i+1,j ,k ) +
330 zp_arr(i,j+1,k ) + zp_arr(i+1,j+1,k ) +
331 zp_arr(i,j ,k+1) + zp_arr(i+1,j ,k+1) +
332 zp_arr(i,j+1,k+1) + zp_arr(i+1,j+1,k+1) );
333 });
334 } // mfi
335 mf_comp += AMREX_SPACEDIM;
336 } // if containerHasElement
337
338#ifdef REMORA_USE_PARTICLES
339 const auto& particles_namelist( particleData.getNames() );
340 for (ParticlesNamesVector::size_type i = 0; i < particles_namelist.size(); i++) {
341 if (containerHasElement(plot_var_names, std::string(particles_namelist[i]+"_count"))) {
342 MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 0);
343 temp_dat.setVal(0);
344 particleData[particles_namelist[i]]->Increment(temp_dat, lev);
345 MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
346 mf_comp += 1;
347 }
348 }
349
350 Vector<std::string> particle_mesh_plot_names(0);
351 particleData.GetMeshPlotVarNames( particle_mesh_plot_names );
352 for (int i = 0; i < particle_mesh_plot_names.size(); i++) {
353 std::string plot_var_name(particle_mesh_plot_names[i]);
354 if (containerHasElement(plot_var_names, plot_var_name) ) {
355 MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 1);
356 temp_dat.setVal(0);
357 particleData.GetMeshPlotVar(plot_var_name, temp_dat, lev);
358 MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
359 mf_comp += 1;
360 }
361 }
362#endif
363
364 MultiFab::Copy(mf_nd[lev],*vec_z_phys_nd[lev],0,2,1,0);
365 Real dz = Geom()[lev].CellSizeArray()[2];
366 int N = Geom()[lev].Domain().size()[2];
367
368#ifdef _OPENMP
369#pragma omp parallel if (Gpu::notInLaunchRegion())
370#endif
371 for (MFIter mfi(mf_nd[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi)
372 {
373 const Box& bx = mfi.tilebox();
374 Array4<Real> mf_arr = mf_nd[lev].array(mfi);
375 ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) {
376 mf_arr(i,j,k,2) = mf_arr(i,j,k,2) + (N-k) * dz;
377 });
378 } // mfi
379
380 } // lev
381
382 std::string plotfilename = Concatenate(plot_file_name, istep[0], file_min_digits);
383
384 if (finest_level == 0)
385 {
387 amrex::Print() << "Writing plotfile " << plotfilename << "\n";
388 WriteMultiLevelPlotfileWithBathymetry(plotfilename, finest_level+1,
389 GetVecOfConstPtrs(mf),
390 GetVecOfConstPtrs(mf_nd),
391 GetVecOfConstPtrs(mf_u),
392 GetVecOfConstPtrs(mf_v),
393 GetVecOfConstPtrs(mf_w),
394 varnames,
395 t_new[0], istep);
396 writeJobInfo(plotfilename);
397
398#ifdef REMORA_USE_PARTICLES
399 particleData.Checkpoint(plotfilename);
400#endif
401
402#ifdef REMORA_USE_HDF5
403 } else if (plotfile_type == PlotfileType::hdf5) {
404 amrex::Print() << "Writing plotfile " << plotfilename+"d01.h5" << "\n";
405 WriteMultiLevelPlotfileHDF5(plotfilename, finest_level+1,
406 GetVecOfConstPtrs(mf),
407 varnames,
408 Geom(), t_new[0], istep, refRatio());
409#endif
410 } else if (!(plotfile_type == PlotfileType::netcdf)) {
411 amrex::Abort("User specified unknown plot_filetype");
412 }
413
414 } else { // multilevel
415
416 Vector<IntVect> r2(finest_level);
417 Vector<Geometry> g2(finest_level+1);
418 Vector<MultiFab> mf2(finest_level+1);
419
420 mf2[0].define(grids[0], dmap[0], ncomp_mf, 0);
421
422 // Copy level 0 as is
423 MultiFab::Copy(mf2[0],mf[0],0,0,mf[0].nComp(),0);
424
425 // Define a new multi-level array of Geometry's so that we pass the new "domain" at lev > 0
426 Array<int,AMREX_SPACEDIM> periodicity =
427 {Geom()[0].isPeriodic(0),Geom()[0].isPeriodic(1),Geom()[0].isPeriodic(2)};
428 g2[0].define(Geom()[0].Domain(),&(Geom()[0].ProbDomain()),0,periodicity.data());
429
431 r2[0] = IntVect(1,1,ref_ratio[0][0]);
432 for (int lev = 1; lev <= finest_level; ++lev) {
433 if (lev > 1) {
434 r2[lev-1][0] = 1;
435 r2[lev-1][1] = 1;
436 r2[lev-1][2] = r2[lev-2][2] * ref_ratio[lev-1][0];
437 }
438
439 mf2[lev].define(refine(grids[lev],r2[lev-1]), dmap[lev], ncomp_mf, 0);
440
441 // Set the new problem domain
442 Box d2(Geom()[lev].Domain());
443 d2.refine(r2[lev-1]);
444
445 g2[lev].define(d2,&(Geom()[lev].ProbDomain()),0,periodicity.data());
446 }
447
448 // Make a vector of BCRec with default values so we can use it here -- note the values
449 // aren't actually used because we do PCInterp
450 amrex::Vector<amrex::BCRec> null_dom_bcs;
451 null_dom_bcs.resize(mf2[0].nComp());
452 for (int n = 0; n < mf2[0].nComp(); n++) {
453 for (int dir = 0; dir < AMREX_SPACEDIM; dir++) {
454 null_dom_bcs[n].setLo(dir, REMORABCType::int_dir);
455 null_dom_bcs[n].setHi(dir, REMORABCType::int_dir);
456 }
457 }
458
459 // Do piecewise interpolation of mf into mf2
460 for (int lev = 1; lev <= finest_level; ++lev) {
461 Interpolater* mapper_c = &pc_interp;
462 InterpFromCoarseLevel(mf2[lev], t_new[lev], mf[lev],
463 0, 0, mf2[lev].nComp(),
464 geom[lev], g2[lev],
466 r2[lev-1], mapper_c, null_dom_bcs, 0);
467 }
468
469 // Define an effective ref_ratio which is isotropic to be passed into WriteMultiLevelPlotfile
470 Vector<IntVect> rr(finest_level);
471 for (int lev = 0; lev < finest_level; ++lev) {
472 rr[lev] = IntVect(ref_ratio[lev][0],ref_ratio[lev][1],ref_ratio[lev][0]);
473 }
474
475 WriteMultiLevelPlotfile(plotfilename, finest_level+1, GetVecOfConstPtrs(mf2), varnames,
476 g2, t_new[0], istep, rr);
477 writeJobInfo(plotfilename);
478
479#ifdef REMORA_USE_PARTICLES
480 particleData.Checkpoint(plotfilename);
481#endif
482 }
483 } // end multi-level
484 for (int lev = 0; lev <= finest_level; ++lev) {
485 mask_arrays_for_write(lev, 0.0_rt, (Real) fill_value);
486 }
487}
488
489/**
490 * @param plotfilename name of plotfile to write to
491 * @param nlevels number of levels to write out
492 * @param mf MultiFab of data to write out
493 * @param mf_nd Multifab of nodal data to write out
494 * @param varnames variable names to write out
495 * @param time time at which to output
496 * @param level_steps vector over level of iterations
497 * @param versionName version string for VisIt
498 * @param levelPrefix string to prepend to level number
499 * @param mfPrefix subdirectory for multifab data
500 * @param extra_dirs additional subdirectories within plotfile
501 */
502 void
503 REMORA::WriteMultiLevelPlotfileWithBathymetry (const std::string& plotfilename, int nlevels,
504 const Vector<const MultiFab*>& mf,
505 const Vector<const MultiFab*>& mf_nd,
506 const Vector<const MultiFab*>& mf_u,
507 const Vector<const MultiFab*>& mf_v,
508 const Vector<const MultiFab*>& mf_w,
509 const Vector<std::string>& varnames,
510 Real time,
511 const Vector<int>& level_steps,
512 const std::string &versionName,
513 const std::string &levelPrefix,
514 const std::string &mfPrefix,
515 const Vector<std::string>& extra_dirs) const
516{
517 BL_PROFILE("WriteMultiLevelPlotfileWithBathymetry()");
518
519 BL_ASSERT(nlevels <= mf.size());
520 BL_ASSERT(nlevels <= ref_ratio.size()+1);
521 BL_ASSERT(nlevels <= level_steps.size());
522 BL_ASSERT(mf[0]->nComp() == varnames.size());
523
524 bool callBarrier(false);
525 PreBuildDirectorHierarchy(plotfilename, levelPrefix, nlevels, callBarrier);
526 if (!extra_dirs.empty()) {
527 for (const auto& d : extra_dirs) {
528 const std::string ed = plotfilename+"/"+d;
529 PreBuildDirectorHierarchy(ed, levelPrefix, nlevels, callBarrier);
530 }
531 }
532 ParallelDescriptor::Barrier();
533
534 if (ParallelDescriptor::MyProc() == ParallelDescriptor::NProcs()-1) {
535 Vector<BoxArray> boxArrays(nlevels);
536 for(int level(0); level < boxArrays.size(); ++level) {
537 boxArrays[level] = mf[level]->boxArray();
538 }
539
540 auto f = [=]() {
541 VisMF::IO_Buffer io_buffer(VisMF::IO_Buffer_Size);
542 std::string HeaderFileName(plotfilename + "/Header");
543 std::ofstream HeaderFile;
544 HeaderFile.rdbuf()->pubsetbuf(io_buffer.dataPtr(), io_buffer.size());
545 HeaderFile.open(HeaderFileName.c_str(), std::ofstream::out |
546 std::ofstream::trunc |
547 std::ofstream::binary);
548 if( ! HeaderFile.good()) FileOpenFailed(HeaderFileName);
549 WriteGenericPlotfileHeaderWithBathymetry(HeaderFile, nlevels, boxArrays, varnames,
550 time, level_steps, versionName,
551 levelPrefix, mfPrefix);
552 };
553
554 if (AsyncOut::UseAsyncOut()) {
555 AsyncOut::Submit(std::move(f));
556 } else {
557 f();
558 }
559 }
560
561 std::string mf_nodal_prefix = "Nu_nd";
562 std::string mf_uface_prefix = "UonXFace";
563 std::string mf_vface_prefix = "VonYFace";
564 std::string mf_wface_prefix = "WonZFace";
565
566 for (int level = 0; level <= finest_level; ++level)
567 {
568 if (AsyncOut::UseAsyncOut()) {
569 VisMF::AsyncWrite(*mf[level],
570 MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix),
571 true);
572 VisMF::AsyncWrite(*mf_nd[level],
573 MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix),
574 true);
576 VisMF::AsyncWrite(*mf_u[level],
577 MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_uface_prefix),
578 true);
579 VisMF::AsyncWrite(*mf_v[level],
580 MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_vface_prefix),
581 true);
582 VisMF::AsyncWrite(*mf_w[level],
583 MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_wface_prefix),
584 true);
585 }
586 } else { const MultiFab* data;
587 std::unique_ptr<MultiFab> mf_tmp;
588 if (mf[level]->nGrowVect() != 0) {
589 mf_tmp = std::make_unique<MultiFab>(mf[level]->boxArray(),
590 mf[level]->DistributionMap(),
591 mf[level]->nComp(), 0, MFInfo(),
592 mf[level]->Factory());
593 MultiFab::Copy(*mf_tmp, *mf[level], 0, 0, mf[level]->nComp(), 0);
594 data = mf_tmp.get();
595 } else {
596 data = mf[level];
597 }
598 VisMF::Write(*data , MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix));
599 VisMF::Write(*mf_nd[level], MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix));
601 VisMF::Write(*mf_u[level], MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_uface_prefix));
602 VisMF::Write(*mf_v[level], MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_vface_prefix));
603 VisMF::Write(*mf_w[level], MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_wface_prefix));
604 }
605 }
606 }
607}
608
609/**
610 * @param HeaderFile output stream for header
611 * @param nlevels number of levels to write out
612 * @param bArray vector over levels of BoxArrays
613 * @param varnames variable names to write out
614 * @param time time at which to output
615 * @param level_steps vector over level of iterations
616 * @param versionName version string for VisIt
617 * @param levelPrefix string to prepend to level number
618 * @param mfPrefix subdirectory for multifab data
619 */
620void
622 int nlevels,
623 const Vector<BoxArray> &bArray,
624 const Vector<std::string> &varnames,
625 Real time,
626 const Vector<int> &level_steps,
627 const std::string &versionName,
628 const std::string &levelPrefix,
629 const std::string &mfPrefix) const
630{
631 BL_ASSERT(nlevels <= bArray.size());
632 BL_ASSERT(nlevels <= ref_ratio.size()+1);
633 BL_ASSERT(nlevels <= level_steps.size());
634
635 HeaderFile.precision(17);
636
637 // ---- this is the generic plot file type name
638 HeaderFile << versionName << '\n';
639
640 HeaderFile << varnames.size() << '\n';
641
642 for (int ivar = 0; ivar < varnames.size(); ++ivar) {
643 HeaderFile << varnames[ivar] << "\n";
644 }
645 HeaderFile << AMREX_SPACEDIM << '\n';
646 HeaderFile << time << '\n';
647 HeaderFile << finest_level << '\n';
648 for (int i = 0; i < AMREX_SPACEDIM; ++i) {
649 HeaderFile << geom[0].ProbLo(i) << ' ';
650 }
651 HeaderFile << '\n';
652 for (int i = 0; i < AMREX_SPACEDIM; ++i) {
653 HeaderFile << geom[0].ProbHi(i) << ' ';
654 }
655 HeaderFile << '\n';
656 for (int i = 0; i < finest_level; ++i) {
657 HeaderFile << ref_ratio[i][0] << ' ';
658 }
659 HeaderFile << '\n';
660 for (int i = 0; i <= finest_level; ++i) {
661 HeaderFile << geom[i].Domain() << ' ';
662 }
663 HeaderFile << '\n';
664 for (int i = 0; i <= finest_level; ++i) {
665 HeaderFile << level_steps[i] << ' ';
666 }
667 HeaderFile << '\n';
668 for (int i = 0; i <= finest_level; ++i) {
669 for (int k = 0; k < AMREX_SPACEDIM; ++k) {
670 HeaderFile << geom[i].CellSize()[k] << ' ';
671 }
672 HeaderFile << '\n';
673 }
674 HeaderFile << (int) geom[0].Coord() << '\n';
675 HeaderFile << "0\n";
676
677 for (int level = 0; level <= finest_level; ++level) {
678 HeaderFile << level << ' ' << bArray[level].size() << ' ' << time << '\n';
679 HeaderFile << level_steps[level] << '\n';
680
681 const IntVect& domain_lo = geom[level].Domain().smallEnd();
682 for (int i = 0; i < bArray[level].size(); ++i)
683 {
684 // Need to shift because the RealBox ctor we call takes the
685 // physical location of index (0,0,0). This does not affect
686 // the usual cases where the domain index starts with 0.
687 const Box& b = shift(bArray[level][i], -domain_lo);
688 RealBox loc = RealBox(b, geom[level].CellSize(), geom[level].ProbLo());
689 for (int n = 0; n < AMREX_SPACEDIM; ++n) {
690 HeaderFile << loc.lo(n) << ' ' << loc.hi(n) << '\n';
691 }
692 }
693
694 HeaderFile << MultiFabHeaderPath(level, levelPrefix, mfPrefix) << '\n';
695 }
696 HeaderFile << "1" << "\n";
697 HeaderFile << "3" << "\n";
698 HeaderFile << "amrexvec_nu_x" << "\n";
699 HeaderFile << "amrexvec_nu_y" << "\n";
700 HeaderFile << "amrexvec_nu_z" << "\n";
701 std::string mf_nodal_prefix = "Nu_nd";
702 for (int level = 0; level <= finest_level; ++level) {
703 HeaderFile << MultiFabHeaderPath(level, levelPrefix, mf_nodal_prefix) << '\n';
704 }
705}
706
707/**
708 * @param lev level to mask
709 * @param fill_value fill value to mask with
710 * @param fill_where value at cells where we will apply the mask. This is necessary because rivers
711 */
712void
713REMORA::mask_arrays_for_write(int lev, Real fill_value, Real fill_where) {
714 for (MFIter mfi(*cons_new[lev],false); mfi.isValid(); ++mfi) {
715 Box gbx1 = mfi.growntilebox(IntVect(NGROW+1,NGROW+1,0));
716 Box ubx = mfi.grownnodaltilebox(0,IntVect(NGROW,NGROW,0));
717 Box vbx = mfi.grownnodaltilebox(1,IntVect(NGROW,NGROW,0));
718
719 Array4<Real> const& Zt_avg1 = vec_Zt_avg1[lev]->array(mfi);
720 Array4<Real> const& ubar = vec_ubar[lev]->array(mfi);
721 Array4<Real> const& vbar = vec_vbar[lev]->array(mfi);
722 Array4<Real> const& xvel = xvel_new[lev]->array(mfi);
723 Array4<Real> const& yvel = yvel_new[lev]->array(mfi);
724 Array4<Real> const& temp = cons_new[lev]->array(mfi,Temp_comp);
725 Array4<Real> const& salt = cons_new[lev]->array(mfi,Salt_comp);
726
727 Array4<Real const> const& mskr = vec_mskr[lev]->array(mfi);
728 Array4<Real const> const& msku = vec_msku[lev]->array(mfi);
729 Array4<Real const> const& mskv = vec_mskv[lev]->array(mfi);
730
731 ParallelFor(makeSlab(gbx1,2,0), [=] AMREX_GPU_DEVICE (int i, int j, int )
732 {
733 if (!mskr(i,j,0)) {
734 Zt_avg1(i,j,0) = fill_value;
735 }
736 });
737 ParallelFor(gbx1, [=] AMREX_GPU_DEVICE (int i, int j, int k)
738 {
739 if (!mskr(i,j,0)) {
740 temp(i,j,k) = fill_value;
741 salt(i,j,k) = fill_value;
742 }
743 });
744 ParallelFor(makeSlab(ubx,2,0), 3, [=] AMREX_GPU_DEVICE (int i, int j, int , int n)
745 {
746 if (!msku(i,j,0) && ubar(i,j,0)==fill_where) {
747 ubar(i,j,0,n) = fill_value;
748 }
749 });
750 ParallelFor(makeSlab(vbx,2,0), 3, [=] AMREX_GPU_DEVICE (int i, int j, int , int n)
751 {
752 if (!mskv(i,j,0) && vbar(i,j,0)==fill_where) {
753 vbar(i,j,0,n) = fill_value;
754 }
755 });
756 ParallelFor(ubx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
757 {
758 if (!msku(i,j,0) && xvel(i,j,k)==fill_where) {
759 xvel(i,j,k) = fill_value;
760 }
761 });
762 ParallelFor(vbx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
763 {
764 if (!mskv(i,j,0) && yvel(i,j,k)==fill_where) {
765 yvel(i,j,k) = fill_value;
766 }
767 });
768 }
769 Gpu::streamSynchronize();
770}
Coord
Coordinates.
#define NGROW
#define Temp_comp
#define Salt_comp
#define NCONS
bool containerHasElement(const V &iterable, const T &query)
PhysBCFunctNoOp null_bc_for_fill
static PlotfileType plotfile_type
Native or NetCDF plotfile output.
Definition REMORA.H:1320
const amrex::Vector< std::string > cons_names
Names of scalars for plotfile output.
Definition REMORA.H:1273
amrex::Vector< amrex::BCRec > domain_bcs_type
vector (over BCVars) of BCRecs
Definition REMORA.H:1178
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_pm
horizontal scaling factor: 1 / dx (2D)
Definition REMORA.H:366
amrex::Vector< std::string > plot_var_names
Names of variables to output to AMReX plotfile.
Definition REMORA.H:1271
amrex::Vector< amrex::MultiFab * > cons_new
multilevel data container for current step's scalar data: temperature, salinity, passive scalar
Definition REMORA.H:223
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_mskr
land/sea mask at cell centers (2D)
Definition REMORA.H:357
void writeJobInfo(const std::string &dir) const
Write job info to stdout.
amrex::Vector< amrex::MultiFab * > zvel_new
multilevel data container for current step's z velocities (largely unused; W stored separately)
Definition REMORA.H:229
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_msku
land/sea mask at x-faces (2D)
Definition REMORA.H:359
void FillPatchNoBC(int lev, amrex::Real time, amrex::MultiFab &mf_to_be_filled, amrex::Vector< amrex::MultiFab * > const &mfs, const int bdy_var_type=BdyVars::null, const int icomp=0, const bool fill_all=true, const bool fill_set=true)
Fill a new MultiFab by copying in phi from valid region and filling ghost cells without applying boun...
void setPlotVariables(const std::string &pp_plot_var_names)
amrex::Vector< amrex::MultiFab * > yvel_new
multilevel data container for current step's y velocities (v in ROMS)
Definition REMORA.H:227
amrex::Vector< amrex::MultiFab * > xvel_new
multilevel data container for current step's x velocities (u in ROMS)
Definition REMORA.H:225
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_mskv
land/sea mask at y-faces (2D)
Definition REMORA.H:361
void WriteGenericPlotfileHeaderWithBathymetry(std::ostream &HeaderFile, int nlevels, const amrex::Vector< amrex::BoxArray > &bArray, const amrex::Vector< std::string > &varnames, amrex::Real time, const amrex::Vector< int > &level_steps, const std::string &versionName, const std::string &levelPrefix, const std::string &mfPrefix) const
write out header data for an AMReX plotfile
amrex::Vector< int > istep
which step?
Definition REMORA.H:1152
void mask_arrays_for_write(int lev, amrex::Real fill_value, amrex::Real fill_where)
Mask data arrays before writing output.
static int file_min_digits
Minimum number of digits in plotfile name or chunked history file.
Definition REMORA.H:1314
std::string pp_prefix
default prefix for input file parameters
Definition REMORA.H:211
amrex::Vector< amrex::Real > t_new
new time at each level
Definition REMORA.H:1156
static int plot_staggered_vels
Whether to write the staggered velocities (not averaged to cell centers)
Definition REMORA.H:1317
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_vbar
barotropic y velocity (2D)
Definition REMORA.H:352
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_ubar
barotropic x velocity (2D)
Definition REMORA.H:350
void WriteMultiLevelPlotfileWithBathymetry(const std::string &plotfilename, int nlevels, const amrex::Vector< const amrex::MultiFab * > &mf, const amrex::Vector< const amrex::MultiFab * > &mf_nd, const amrex::Vector< const amrex::MultiFab * > &mf_u, const amrex::Vector< const amrex::MultiFab * > &mf_v, const amrex::Vector< const amrex::MultiFab * > &mf_w, const amrex::Vector< std::string > &varnames, amrex::Real time, const amrex::Vector< int > &level_steps, const std::string &versionName="HyperCLaw-V1.1", const std::string &levelPrefix="Level_", const std::string &mfPrefix="Cell", const amrex::Vector< std::string > &extra_dirs=amrex::Vector< std::string >()) const
write out particular data to an AMReX plotfile
void appendPlotVariables(const std::string &pp_plot_var_names)
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_z_phys_nd
z coordinates at psi points (cell nodes)
Definition REMORA.H:287
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_pn
horizontal scaling factor: 1 / dy (2D)
Definition REMORA.H:368
std::string plot_file_name
Plotfile prefix.
Definition REMORA.H:1248
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_Zt_avg1
Average of the free surface, zeta (2D)
Definition REMORA.H:290
void WritePlotFile()
main driver for writing AMReX plotfiles
const amrex::Vector< std::string > derived_names
Names of derived fields for plotfiles.
Definition REMORA.H:1276
void remora_dernull(const amrex::Box &, amrex::FArrayBox &, int, int, const amrex::FArrayBox &, const amrex::Array4< const amrex::Real > &, const amrex::Array4< const amrex::Real > &, const amrex::Geometry &, amrex::Real, const int *, const int)
void remora_dervort(const amrex::Box &bx, amrex::FArrayBox &derfab, int dcomp, int ncomp, const amrex::FArrayBox &datfab, const amrex::Array4< const amrex::Real > &pm, const amrex::Array4< const amrex::Real > &pn, const amrex::Geometry &, amrex::Real, const int *, const int)