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 // Array of MultiFabs to hold the plotfile data
169 Vector<MultiFab> mf(finest_level+1);
170 for (int lev = 0; lev <= finest_level; ++lev) {
171 mf[lev].define(grids[lev], dmap[lev], ncomp_mf, ngrow_vars);
172 }
173
174 // Array of MultiFabs for nodal data
175 Vector<MultiFab> mf_nd(finest_level+1);
176 for (int lev = 0; lev <= finest_level; ++lev) {
177 BoxArray nodal_grids(grids[lev]); nodal_grids.surroundingNodes();
178 mf_nd[lev].define(nodal_grids, dmap[lev], AMREX_SPACEDIM, 0);
179 mf_nd[lev].setVal(0.);
180 }
181
182 // Array of MultiFabs for cell-centered velocity
183 Vector<MultiFab> mf_cc_vel(finest_level+1);
184
185 if (containerHasElement(plot_var_names, "x_velocity") ||
186 containerHasElement(plot_var_names, "y_velocity") ||
187 containerHasElement(plot_var_names, "z_velocity") ||
188 containerHasElement(plot_var_names, "vorticity") ) {
189
190 for (int lev = 0; lev <= finest_level; ++lev) {
191 mf_cc_vel[lev].define(grids[lev], dmap[lev], AMREX_SPACEDIM, IntVect(1,1,0));
192 mf_cc_vel[lev].setVal(0.0_rt); // zero out velocity in case we have any wall boundaries
193 average_face_to_cellcenter(mf_cc_vel[lev],0,
194 Array<const MultiFab*,3>{xvel_new[lev],yvel_new[lev],zvel_new[lev]});
195 mf_cc_vel[lev].FillBoundary(geom[lev].periodicity());
196 } // lev
197
198 // We need ghost cells if computing vorticity
199 amrex::Interpolater* mapper = &cell_cons_interp;
200 if ( containerHasElement(plot_var_names, "vorticity") ) {
201 for (int lev = 1; lev <= finest_level; ++lev) {
202 Vector<MultiFab*> fmf = {&(mf_cc_vel[lev]), &(mf_cc_vel[lev])};
203 Vector<Real> ftime = {t_new[lev], t_new[lev]};
204 Vector<MultiFab*> cmf = {&mf_cc_vel[lev-1], &mf_cc_vel[lev-1]};
205 Vector<Real> ctime = {t_new[lev], t_new[lev]};
206
207 MultiFab mf_to_fill;
208 amrex::FillPatchTwoLevels(mf_cc_vel[lev], t_new[lev], cmf, ctime, fmf, ftime,
209 0, 0, AMREX_SPACEDIM, geom[lev-1], geom[lev],
210 null_bc_for_fill, 0, null_bc_for_fill, 0, refRatio(lev-1),
211 mapper, domain_bcs_type, 0);
212 } // lev
213 } // if
214 } // if
215
216 for (int lev = 0; lev <= finest_level; ++lev)
217 {
218 int mf_comp = 0;
219
220 // First, copy any of the conserved state variables into the output plotfile
221 AMREX_ALWAYS_ASSERT(cons_names.size() == NCONS);
222 for (int i = 0; i < NCONS; ++i) {
224 if (cons_new[lev]->contains_nan() || cons_new[lev]->contains_inf()) {
225 amrex::Abort("Found while writing output: Cons (salt, temp, or scalar, etc) contains nan or inf");
226 }
227 MultiFab::Copy(mf[lev],*cons_new[lev],i,mf_comp,1,ngrow_vars);
228 mf_comp++;
229 }
230 } // NCONS
231
232 // Next, check for velocities
233 if (containerHasElement(plot_var_names, "x_velocity")) {
234 if (mf_cc_vel[lev].contains_nan(0,1) || mf_cc_vel[lev].contains_inf(0,1)) {
235 amrex::Abort("Found while writing output: u velocity contains nan or inf");
236 }
237 MultiFab::Copy(mf[lev], mf_cc_vel[lev], 0, mf_comp, 1, 0);
238 mf_comp += 1;
239 }
240 if (containerHasElement(plot_var_names, "y_velocity")) {
241 if (mf_cc_vel[lev].contains_nan(1,1) || mf_cc_vel[lev].contains_inf(1,1)) {
242 amrex::Abort("Found while writing output: v velocity contains nan or inf");
243 }
244 MultiFab::Copy(mf[lev], mf_cc_vel[lev], 1, mf_comp, 1, 0);
245 mf_comp += 1;
246 }
247 if (containerHasElement(plot_var_names, "z_velocity")) {
248 if (mf_cc_vel[lev].contains_nan(2,1) || mf_cc_vel[lev].contains_inf(2,1)) {
249 amrex::Abort("Found while writing output: z velocity contains nan or inf");
250 }
251 MultiFab::Copy(mf[lev], mf_cc_vel[lev], 2, mf_comp, 1, 0);
252 mf_comp += 1;
253 }
254
255 // Define standard process for calling the functions in Derive.cpp
256 auto calculate_derived = [&](const std::string& der_name,
257 decltype(derived::remora_dernull)& der_function)
258 {
259 if (containerHasElement(plot_var_names, der_name)) {
260 MultiFab dmf(mf[lev], make_alias, mf_comp, 1);
261#ifdef _OPENMP
262#pragma omp parallel if (amrex::Gpu::notInLaunchRegion())
263#endif
264 for (MFIter mfi(dmf, TilingIfNotGPU()); mfi.isValid(); ++mfi)
265 {
266 const Box& bx = mfi.tilebox();
267 auto& dfab = dmf[mfi];
268
269 if (der_name == "vorticity") {
270 auto const& sfab = mf_cc_vel[lev][mfi];
271 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);
272 } else {
273 auto const& sfab = (*cons_new[lev])[mfi];
274 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);
275 }
276 }
277
278 mf_comp++;
279 }
280 };
281
282 // Note: All derived variables must be computed in order of "derived_names" defined in REMORA.H
283 calculate_derived("vorticity", derived::remora_dervort);
284
285 // Fill cell-centered location
286 Real dx = Geom()[lev].CellSizeArray()[0];
287 Real dy = Geom()[lev].CellSizeArray()[1];
288
289 // Next, check for location names -- if we write one we write all
290 if (containerHasElement(plot_var_names, "x_cc") ||
293 {
294 MultiFab dmf(mf[lev], make_alias, mf_comp, AMREX_SPACEDIM);
295#ifdef _OPENMP
296#pragma omp parallel if (Gpu::notInLaunchRegion())
297#endif
298 for (MFIter mfi(dmf, TilingIfNotGPU()); mfi.isValid(); ++mfi) {
299 const Box& bx = mfi.tilebox();
300 const Array4<Real> loc_arr = dmf.array(mfi);
301 const Array4<Real const> zp_arr = vec_z_phys_nd[lev]->const_array(mfi);
302
303 ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) {
304 loc_arr(i,j,k,0) = (i+0.5_rt) * dx;
305 loc_arr(i,j,k,1) = (j+0.5_rt) * dy;
306 loc_arr(i,j,k,2) = 0.125_rt * (zp_arr(i,j ,k ) + zp_arr(i+1,j ,k ) +
307 zp_arr(i,j+1,k ) + zp_arr(i+1,j+1,k ) +
308 zp_arr(i,j ,k+1) + zp_arr(i+1,j ,k+1) +
309 zp_arr(i,j+1,k+1) + zp_arr(i+1,j+1,k+1) );
310 });
311 } // mfi
312 mf_comp += AMREX_SPACEDIM;
313 } // if containerHasElement
314
315#ifdef REMORA_USE_PARTICLES
316 const auto& particles_namelist( particleData.getNames() );
317 for (ParticlesNamesVector::size_type i = 0; i < particles_namelist.size(); i++) {
318 if (containerHasElement(plot_var_names, std::string(particles_namelist[i]+"_count"))) {
319 MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 0);
320 temp_dat.setVal(0);
321 particleData[particles_namelist[i]]->Increment(temp_dat, lev);
322 MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
323 mf_comp += 1;
324 }
325 }
326
327 Vector<std::string> particle_mesh_plot_names(0);
328 particleData.GetMeshPlotVarNames( particle_mesh_plot_names );
329 for (int i = 0; i < particle_mesh_plot_names.size(); i++) {
330 std::string plot_var_name(particle_mesh_plot_names[i]);
331 if (containerHasElement(plot_var_names, plot_var_name) ) {
332 MultiFab temp_dat(mf[lev].boxArray(), mf[lev].DistributionMap(), 1, 1);
333 temp_dat.setVal(0);
334 particleData.GetMeshPlotVar(plot_var_name, temp_dat, lev);
335 MultiFab::Copy(mf[lev], temp_dat, 0, mf_comp, 1, 0);
336 mf_comp += 1;
337 }
338 }
339#endif
340
341 MultiFab::Copy(mf_nd[lev],*vec_z_phys_nd[lev],0,2,1,0);
342 Real dz = Geom()[lev].CellSizeArray()[2];
343 int N = Geom()[lev].Domain().size()[2];
344
345#ifdef _OPENMP
346#pragma omp parallel if (Gpu::notInLaunchRegion())
347#endif
348 for (MFIter mfi(mf_nd[lev], TilingIfNotGPU()); mfi.isValid(); ++mfi)
349 {
350 const Box& bx = mfi.tilebox();
351 Array4<Real> mf_arr = mf_nd[lev].array(mfi);
352 ParallelFor(bx, [=] AMREX_GPU_DEVICE (int i, int j, int k) {
353 mf_arr(i,j,k,2) = mf_arr(i,j,k,2) + (N-k) * dz;
354 });
355 } // mfi
356
357 } // lev
358
359 std::string plotfilename = Concatenate(plot_file_name, istep[0], file_min_digits);
360
361 if (finest_level == 0)
362 {
364 amrex::Print() << "Writing plotfile " << plotfilename << "\n";
365 WriteMultiLevelPlotfileWithBathymetry(plotfilename, finest_level+1,
366 GetVecOfConstPtrs(mf),
367 GetVecOfConstPtrs(mf_nd),
368 varnames,
369 t_new[0], istep);
370 writeJobInfo(plotfilename);
371
372#ifdef REMORA_USE_PARTICLES
373 particleData.Checkpoint(plotfilename);
374#endif
375
376#ifdef REMORA_USE_HDF5
377 } else if (plotfile_type == PlotfileType::hdf5) {
378 amrex::Print() << "Writing plotfile " << plotfilename+"d01.h5" << "\n";
379 WriteMultiLevelPlotfileHDF5(plotfilename, finest_level+1,
380 GetVecOfConstPtrs(mf),
381 varnames,
382 Geom(), t_new[0], istep, refRatio());
383#endif
384 } else if (!(plotfile_type == PlotfileType::netcdf)) {
385 amrex::Abort("User specified unknown plot_filetype");
386 }
387
388 } else { // multilevel
389
390 Vector<IntVect> r2(finest_level);
391 Vector<Geometry> g2(finest_level+1);
392 Vector<MultiFab> mf2(finest_level+1);
393
394 mf2[0].define(grids[0], dmap[0], ncomp_mf, 0);
395
396 // Copy level 0 as is
397 MultiFab::Copy(mf2[0],mf[0],0,0,mf[0].nComp(),0);
398
399 // Define a new multi-level array of Geometry's so that we pass the new "domain" at lev > 0
400 Array<int,AMREX_SPACEDIM> periodicity =
401 {Geom()[0].isPeriodic(0),Geom()[0].isPeriodic(1),Geom()[0].isPeriodic(2)};
402 g2[0].define(Geom()[0].Domain(),&(Geom()[0].ProbDomain()),0,periodicity.data());
403
405 r2[0] = IntVect(1,1,ref_ratio[0][0]);
406 for (int lev = 1; lev <= finest_level; ++lev) {
407 if (lev > 1) {
408 r2[lev-1][0] = 1;
409 r2[lev-1][1] = 1;
410 r2[lev-1][2] = r2[lev-2][2] * ref_ratio[lev-1][0];
411 }
412
413 mf2[lev].define(refine(grids[lev],r2[lev-1]), dmap[lev], ncomp_mf, 0);
414
415 // Set the new problem domain
416 Box d2(Geom()[lev].Domain());
417 d2.refine(r2[lev-1]);
418
419 g2[lev].define(d2,&(Geom()[lev].ProbDomain()),0,periodicity.data());
420 }
421
422 // Make a vector of BCRec with default values so we can use it here -- note the values
423 // aren't actually used because we do PCInterp
424 amrex::Vector<amrex::BCRec> null_dom_bcs;
425 null_dom_bcs.resize(mf2[0].nComp());
426 for (int n = 0; n < mf2[0].nComp(); n++) {
427 for (int dir = 0; dir < AMREX_SPACEDIM; dir++) {
428 null_dom_bcs[n].setLo(dir, REMORABCType::int_dir);
429 null_dom_bcs[n].setHi(dir, REMORABCType::int_dir);
430 }
431 }
432
433 // Do piecewise interpolation of mf into mf2
434 for (int lev = 1; lev <= finest_level; ++lev) {
435 Interpolater* mapper_c = &pc_interp;
436 InterpFromCoarseLevel(mf2[lev], t_new[lev], mf[lev],
437 0, 0, mf2[lev].nComp(),
438 geom[lev], g2[lev],
440 r2[lev-1], mapper_c, null_dom_bcs, 0);
441 }
442
443 // Define an effective ref_ratio which is isotropic to be passed into WriteMultiLevelPlotfile
444 Vector<IntVect> rr(finest_level);
445 for (int lev = 0; lev < finest_level; ++lev) {
446 rr[lev] = IntVect(ref_ratio[lev][0],ref_ratio[lev][1],ref_ratio[lev][0]);
447 }
448
449 WriteMultiLevelPlotfile(plotfilename, finest_level+1, GetVecOfConstPtrs(mf2), varnames,
450 g2, t_new[0], istep, rr);
451 writeJobInfo(plotfilename);
452
453#ifdef REMORA_USE_PARTICLES
454 particleData.Checkpoint(plotfilename);
455#endif
456 }
457 } // end multi-level
458}
459
460/**
461 * @param plotfilename name of plotfile to write to
462 * @param nlevels number of levels to write out
463 * @param mf MultiFab of data to write out
464 * @param mf_nd Multifab of nodal data to write out
465 * @param varnames variable names to write out
466 * @param time time at which to output
467 * @param level_steps vector over level of iterations
468 * @param versionName version string for VisIt
469 * @param levelPrefix string to prepend to level number
470 * @param mfPrefix subdirectory for multifab data
471 * @param extra_dirs additional subdirectories within plotfile
472 */
473 void
474 REMORA::WriteMultiLevelPlotfileWithBathymetry (const std::string& plotfilename, int nlevels,
475 const Vector<const MultiFab*>& mf,
476 const Vector<const MultiFab*>& mf_nd,
477 const Vector<std::string>& varnames,
478 Real time,
479 const Vector<int>& level_steps,
480 const std::string &versionName,
481 const std::string &levelPrefix,
482 const std::string &mfPrefix,
483 const Vector<std::string>& extra_dirs) const
484{
485 BL_PROFILE("WriteMultiLevelPlotfileWithBathymetry()");
486
487 BL_ASSERT(nlevels <= mf.size());
488 BL_ASSERT(nlevels <= ref_ratio.size()+1);
489 BL_ASSERT(nlevels <= level_steps.size());
490 BL_ASSERT(mf[0]->nComp() == varnames.size());
491
492 bool callBarrier(false);
493 PreBuildDirectorHierarchy(plotfilename, levelPrefix, nlevels, callBarrier);
494 if (!extra_dirs.empty()) {
495 for (const auto& d : extra_dirs) {
496 const std::string ed = plotfilename+"/"+d;
497 PreBuildDirectorHierarchy(ed, levelPrefix, nlevels, callBarrier);
498 }
499 }
500 ParallelDescriptor::Barrier();
501
502 if (ParallelDescriptor::MyProc() == ParallelDescriptor::NProcs()-1) {
503 Vector<BoxArray> boxArrays(nlevels);
504 for(int level(0); level < boxArrays.size(); ++level) {
505 boxArrays[level] = mf[level]->boxArray();
506 }
507
508 auto f = [=]() {
509 VisMF::IO_Buffer io_buffer(VisMF::IO_Buffer_Size);
510 std::string HeaderFileName(plotfilename + "/Header");
511 std::ofstream HeaderFile;
512 HeaderFile.rdbuf()->pubsetbuf(io_buffer.dataPtr(), io_buffer.size());
513 HeaderFile.open(HeaderFileName.c_str(), std::ofstream::out |
514 std::ofstream::trunc |
515 std::ofstream::binary);
516 if( ! HeaderFile.good()) FileOpenFailed(HeaderFileName);
517 WriteGenericPlotfileHeaderWithBathymetry(HeaderFile, nlevels, boxArrays, varnames,
518 time, level_steps, versionName,
519 levelPrefix, mfPrefix);
520 };
521
522 if (AsyncOut::UseAsyncOut()) {
523 AsyncOut::Submit(std::move(f));
524 } else {
525 f();
526 }
527 }
528
529 std::string mf_nodal_prefix = "Nu_nd";
530 for (int level = 0; level <= finest_level; ++level)
531 {
532 if (AsyncOut::UseAsyncOut()) {
533 VisMF::AsyncWrite(*mf[level],
534 MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix),
535 true);
536 VisMF::AsyncWrite(*mf_nd[level],
537 MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix),
538 true);
539 } else {
540 const MultiFab* data;
541 std::unique_ptr<MultiFab> mf_tmp;
542 if (mf[level]->nGrowVect() != 0) {
543 mf_tmp = std::make_unique<MultiFab>(mf[level]->boxArray(),
544 mf[level]->DistributionMap(),
545 mf[level]->nComp(), 0, MFInfo(),
546 mf[level]->Factory());
547 MultiFab::Copy(*mf_tmp, *mf[level], 0, 0, mf[level]->nComp(), 0);
548 data = mf_tmp.get();
549 } else {
550 data = mf[level];
551 }
552 VisMF::Write(*data , MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mfPrefix));
553 VisMF::Write(*mf_nd[level], MultiFabFileFullPrefix(level, plotfilename, levelPrefix, mf_nodal_prefix));
554 }
555 }
556}
557
558/**
559 * @param HeaderFile output stream for header
560 * @param nlevels number of levels to write out
561 * @param bArray vector over levels of BoxArrays
562 * @param varnames variable names to write out
563 * @param time time at which to output
564 * @param level_steps vector over level of iterations
565 * @param versionName version string for VisIt
566 * @param levelPrefix string to prepend to level number
567 * @param mfPrefix subdirectory for multifab data
568 */
569void
571 int nlevels,
572 const Vector<BoxArray> &bArray,
573 const Vector<std::string> &varnames,
574 Real time,
575 const Vector<int> &level_steps,
576 const std::string &versionName,
577 const std::string &levelPrefix,
578 const std::string &mfPrefix) const
579{
580 BL_ASSERT(nlevels <= bArray.size());
581 BL_ASSERT(nlevels <= ref_ratio.size()+1);
582 BL_ASSERT(nlevels <= level_steps.size());
583
584 HeaderFile.precision(17);
585
586 // ---- this is the generic plot file type name
587 HeaderFile << versionName << '\n';
588
589 HeaderFile << varnames.size() << '\n';
590
591 for (int ivar = 0; ivar < varnames.size(); ++ivar) {
592 HeaderFile << varnames[ivar] << "\n";
593 }
594 HeaderFile << AMREX_SPACEDIM << '\n';
595 HeaderFile << time << '\n';
596 HeaderFile << finest_level << '\n';
597 for (int i = 0; i < AMREX_SPACEDIM; ++i) {
598 HeaderFile << geom[0].ProbLo(i) << ' ';
599 }
600 HeaderFile << '\n';
601 for (int i = 0; i < AMREX_SPACEDIM; ++i) {
602 HeaderFile << geom[0].ProbHi(i) << ' ';
603 }
604 HeaderFile << '\n';
605 for (int i = 0; i < finest_level; ++i) {
606 HeaderFile << ref_ratio[i][0] << ' ';
607 }
608 HeaderFile << '\n';
609 for (int i = 0; i <= finest_level; ++i) {
610 HeaderFile << geom[i].Domain() << ' ';
611 }
612 HeaderFile << '\n';
613 for (int i = 0; i <= finest_level; ++i) {
614 HeaderFile << level_steps[i] << ' ';
615 }
616 HeaderFile << '\n';
617 for (int i = 0; i <= finest_level; ++i) {
618 for (int k = 0; k < AMREX_SPACEDIM; ++k) {
619 HeaderFile << geom[i].CellSize()[k] << ' ';
620 }
621 HeaderFile << '\n';
622 }
623 HeaderFile << (int) geom[0].Coord() << '\n';
624 HeaderFile << "0\n";
625
626 for (int level = 0; level <= finest_level; ++level) {
627 HeaderFile << level << ' ' << bArray[level].size() << ' ' << time << '\n';
628 HeaderFile << level_steps[level] << '\n';
629
630 const IntVect& domain_lo = geom[level].Domain().smallEnd();
631 for (int i = 0; i < bArray[level].size(); ++i)
632 {
633 // Need to shift because the RealBox ctor we call takes the
634 // physical location of index (0,0,0). This does not affect
635 // the usual cases where the domain index starts with 0.
636 const Box& b = shift(bArray[level][i], -domain_lo);
637 RealBox loc = RealBox(b, geom[level].CellSize(), geom[level].ProbLo());
638 for (int n = 0; n < AMREX_SPACEDIM; ++n) {
639 HeaderFile << loc.lo(n) << ' ' << loc.hi(n) << '\n';
640 }
641 }
642
643 HeaderFile << MultiFabHeaderPath(level, levelPrefix, mfPrefix) << '\n';
644 }
645 HeaderFile << "1" << "\n";
646 HeaderFile << "3" << "\n";
647 HeaderFile << "amrexvec_nu_x" << "\n";
648 HeaderFile << "amrexvec_nu_y" << "\n";
649 HeaderFile << "amrexvec_nu_z" << "\n";
650 std::string mf_nodal_prefix = "Nu_nd";
651 for (int level = 0; level <= finest_level; ++level) {
652 HeaderFile << MultiFabHeaderPath(level, levelPrefix, mf_nodal_prefix) << '\n';
653 }
654}
655
656/**
657 * @param lev level to mask
658 * @param fill_value fill value to mask with
659 * @param fill_where value at cells where we will apply the mask. This is necessary because rivers
660 */
661void
662REMORA::mask_arrays_for_write(int lev, Real fill_value, Real fill_where) {
663 for (MFIter mfi(*cons_new[lev],false); mfi.isValid(); ++mfi) {
664 Box gbx1 = mfi.growntilebox(IntVect(NGROW+1,NGROW+1,0));
665 Box ubx = mfi.grownnodaltilebox(0,IntVect(NGROW,NGROW,0));
666 Box vbx = mfi.grownnodaltilebox(1,IntVect(NGROW,NGROW,0));
667
668 Array4<Real> const& Zt_avg1 = vec_Zt_avg1[lev]->array(mfi);
669 Array4<Real> const& ubar = vec_ubar[lev]->array(mfi);
670 Array4<Real> const& vbar = vec_vbar[lev]->array(mfi);
671 Array4<Real> const& xvel = xvel_new[lev]->array(mfi);
672 Array4<Real> const& yvel = yvel_new[lev]->array(mfi);
673 Array4<Real> const& temp = cons_new[lev]->array(mfi,Temp_comp);
674 Array4<Real> const& salt = cons_new[lev]->array(mfi,Salt_comp);
675
676 Array4<Real const> const& mskr = vec_mskr[lev]->array(mfi);
677 Array4<Real const> const& msku = vec_msku[lev]->array(mfi);
678 Array4<Real const> const& mskv = vec_mskv[lev]->array(mfi);
679
680 ParallelFor(makeSlab(gbx1,2,0), [=] AMREX_GPU_DEVICE (int i, int j, int )
681 {
682 if (!mskr(i,j,0)) {
683 Zt_avg1(i,j,0) = fill_value;
684 }
685 });
686 ParallelFor(gbx1, [=] AMREX_GPU_DEVICE (int i, int j, int k)
687 {
688 if (!mskr(i,j,0)) {
689 temp(i,j,k) = fill_value;
690 salt(i,j,k) = fill_value;
691 }
692 });
693 ParallelFor(makeSlab(ubx,2,0), 3, [=] AMREX_GPU_DEVICE (int i, int j, int , int n)
694 {
695 if (!msku(i,j,0) && ubar(i,j,0)==fill_where) {
696 ubar(i,j,0,n) = fill_value;
697 }
698 });
699 ParallelFor(makeSlab(vbx,2,0), 3, [=] AMREX_GPU_DEVICE (int i, int j, int , int n)
700 {
701 if (!mskv(i,j,0) && vbar(i,j,0)==fill_where) {
702 vbar(i,j,0,n) = fill_value;
703 }
704 });
705 ParallelFor(ubx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
706 {
707 if (!msku(i,j,0) && xvel(i,j,k)==fill_where) {
708 xvel(i,j,k) = fill_value;
709 }
710 });
711 ParallelFor(vbx, [=] AMREX_GPU_DEVICE (int i, int j, int k)
712 {
713 if (!mskv(i,j,0) && yvel(i,j,k)==fill_where) {
714 yvel(i,j,k) = fill_value;
715 }
716 });
717 }
718 Gpu::streamSynchronize();
719}
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:1259
const amrex::Vector< std::string > cons_names
Names of scalars for plotfile output.
Definition REMORA.H:1215
amrex::Vector< amrex::BCRec > domain_bcs_type
vector (over BCVars) of BCRecs
Definition REMORA.H:1120
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_pm
horizontal scaling factor: 1 / dx (2D)
Definition REMORA.H:355
amrex::Vector< std::string > plot_var_names
Names of variables to output to AMReX plotfile.
Definition REMORA.H:1213
amrex::Vector< amrex::MultiFab * > cons_new
multilevel data container for current step's scalar data: temperature, salinity, passive scalar
Definition REMORA.H:217
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_mskr
land/sea mask at cell centers (2D)
Definition REMORA.H:346
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:223
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_msku
land/sea mask at x-faces (2D)
Definition REMORA.H:348
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:221
amrex::Vector< amrex::MultiFab * > xvel_new
multilevel data container for current step's x velocities (u in ROMS)
Definition REMORA.H:219
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_mskv
land/sea mask at y-faces (2D)
Definition REMORA.H:350
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:1094
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:1256
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< 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
std::string pp_prefix
default prefix for input file parameters
Definition REMORA.H:205
amrex::Vector< amrex::Real > t_new
new time at each level
Definition REMORA.H:1098
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_vbar
barotropic y velocity (2D)
Definition REMORA.H:341
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_ubar
barotropic x velocity (2D)
Definition REMORA.H:339
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:276
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_pn
horizontal scaling factor: 1 / dy (2D)
Definition REMORA.H:357
std::string plot_file_name
Plotfile prefix.
Definition REMORA.H:1190
amrex::Vector< std::unique_ptr< amrex::MultiFab > > vec_Zt_avg1
Average of the free surface, zeta (2D)
Definition REMORA.H:279
void WritePlotFile()
main driver for writing AMReX plotfiles
const amrex::Vector< std::string > derived_names
Names of derived fields for plotfiles.
Definition REMORA.H:1218
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)