1 #ifndef ERF_NCWPSFILE_H_
2 #define ERF_NCWPSFILE_H_
8 #include "AMReX_FArrayBox.H"
9 #include "AMReX_IArrayBox.H"
50 template <
typename DataType>
53 using DType =
typename std::remove_const<DataType>::type;
56 explicit NDArray (
const std::string vname,
const std::vector<size_t>& vshape)
70 ref_counted.fetch_add(1, std::memory_order_relaxed);
79 ref_counted.fetch_add(1, std::memory_order_relaxed);
85 ref_counted.fetch_sub(1, std::memory_order_acq_rel);
91 ref_counted.fetch_add(1, std::memory_order_relaxed);
108 int isize =
static_cast<int>(
shape.size());
109 for (
auto i=0; i<isize; ++i)
num *=
shape[i];
127 amrex::Vector<amrex::Vector<amrex::FArrayBox>>& bdy_data_xlo,
128 amrex::Vector<amrex::Vector<amrex::FArrayBox>>& bdy_data_xhi,
129 amrex::Vector<amrex::Vector<amrex::FArrayBox>>& bdy_data_ylo,
130 amrex::Vector<amrex::Vector<amrex::FArrayBox>>& bdy_data_yhi);
132 template<
typename DType>
135 amrex::Vector<std::string> names,
137 amrex::Vector<int>& success)
139 amrex::Print() <<
"Reading time slice " << tidx <<
" from " << fname << std::endl;
140 AMREX_ASSERT(arrays.size() == names.size());
142 if (amrex::ParallelDescriptor::IOProcessor())
146 int ntimes = ncf.dim(
"Time").len();
147 AMREX_ALWAYS_ASSERT((tidx >= 0) && (tidx < ntimes));
149 for (
auto n=0; n<arrays.size(); ++n)
151 std::string vname_to_write = names[n];
152 std::string vname_to_read = names[n];
153 if (vname_to_read.substr(0,2) ==
"R_") {
154 vname_to_read = names[n+4];
157 success[n] = ncf.has_var(vname_to_read);
161 std::vector<std::string> dimnames = ncf.var(vname_to_read).dimnames();
162 AMREX_ALWAYS_ASSERT(dimnames[0] ==
"Time");
164 std::vector<size_t> count = ncf.var(vname_to_read).shape();
165 std::vector<size_t> start(count.size(), 0);
170 DType* dataPtr = arrays[n].get_data();
172 ncf.var(vname_to_read).get(dataPtr, start, count);
179 template<
typename DType>
181 amrex::Vector<
NDArray<DType> >& arrays, amrex::Vector<int>& success)
183 AMREX_ASSERT(arrays.size() == names.size());
185 if (amrex::ParallelDescriptor::IOProcessor())
204 for (
auto n=0; n<arrays.size(); ++n)
206 std::string vname_to_write = names[n];
207 std::string vname_to_read = names[n];
209 if (vname_to_read.substr(0,2) ==
"R_") {
210 vname_to_read = names[n+4];
213 success[n] = ncf.has_var(vname_to_read);
214 if (success[n] == 0) {
215 amrex::Print() <<
" Skipping " << vname_to_read << std::endl;
217 amrex::Print() <<
" Reading " << vname_to_read << std::endl;
220 if (success[n] == 1) {
222 std::vector<std::string> dimnames = ncf.var(vname_to_read).dimnames();
223 AMREX_ALWAYS_ASSERT(dimnames[0] ==
"Time" || dimnames[0] ==
"time");
225 std::vector<size_t> shape = ncf.var(vname_to_read).shape();
227 DType* dataPtr = arrays[n].get_data();
229 std::vector<size_t> start(shape.size(), 0);
232 auto numPts = arrays[n].ndim();
233 amrex::Print() <<
"NetCDF Variable name = " << vname_to_read << std::endl;
234 amrex::Print() <<
"numPts read from NetCDF file/var = " << numPts << std::endl;
235 amrex::Print() <<
"Dims in var = " << ncf.var(vname_to_read).ndim() << std::endl;
236 amrex::Print() <<
"Dim names = (";
237 for (
auto &dim:dimnames)
238 amrex::Print() << dim <<
", " ;
239 amrex::Print() <<
")" << std::endl;
240 amrex::Print() <<
"Dims of the variable = (";
241 for (
auto &dim:shape)
242 amrex::Print() << dim <<
", " ;
243 amrex::Print() <<
")" << std::endl;
246 ncf.var(vname_to_read).get(dataPtr, start, shape);
264 template<
class FAB,
typename DType>
267 const amrex::Box& domain,
269 const std::string& var_name,
275 ns1 = nc_arrays[iv].get_vshape()[1];
281 ns2 = nc_arrays[iv].get_vshape()[1];
282 ns3 = nc_arrays[iv].get_vshape()[2];
285 ns1 = nc_arrays[iv].get_vshape()[1];
286 ns2 = nc_arrays[iv].get_vshape()[2];
287 ns3 = nc_arrays[iv].get_vshape()[3];
290 ns1 = nc_arrays[iv].get_vshape()[1];
291 ns2 = nc_arrays[iv].get_vshape()[2];
292 ns3 = nc_arrays[iv].get_vshape()[3];
295 ns1 = nc_arrays[iv].get_vshape()[1];
301 amrex::Abort(
"Dont know this NC_Data_Dims_Type");
308 int khi = std::min(domain.bigEnd(2), ns1-1);
311 amrex::Box in_box(amrex::IntVect(0,0,0), amrex::IntVect(ns3-1,ns2-1,ns1-1));
312 amrex::Box my_box(amrex::IntVect(0,0,0), amrex::IntVect(ns3-1,ns2-1,khi));
314 if (var_name ==
"PH" || var_name ==
"PHB") {
315 my_box.setType(amrex::IndexType(amrex::IntVect(0,0,1)));
316 my_box.setBig(2, khi+1);
318 else if (var_name ==
"U" || var_name ==
"UU" || var_name ==
"MAPFAC_U") {
319 my_box.setType(amrex::IndexType(amrex::IntVect(1,0,0)));
321 else if (var_name ==
"V" || var_name ==
"VV" || var_name ==
"MAPFAC_V") {
322 my_box.setType(amrex::IndexType(amrex::IntVect(0,1,0)));
324 else if (var_name ==
"W" || var_name ==
"WW") {
325 my_box.setType(amrex::IndexType(amrex::IntVect(0,0,1)));
326 my_box.setBig(2, khi+1);
328 else if (var_name ==
"TSLB" || var_name ==
"SMOIS" || var_name ==
"SH2O" || var_name ==
"ZS" || var_name ==
"DZS") {
330 my_box.setType(amrex::IndexType(amrex::IntVect(0,0,1)));
333 amrex::Arena* Arena_Used = amrex::The_Arena();
336 Arena_Used = amrex::The_Pinned_Arena();
338 temp.resize(my_box,1, Arena_Used);
339 amrex::Array4<DType> fab_arr = temp.array();
341 int ioff = temp.box().smallEnd()[0];
342 int joff = temp.box().smallEnd()[1];
343 int kmax = temp.box().bigEnd()[2];
346 auto num_pts = in_box.numPts();
348 for (
int n(0); n < num_pts; ++n) {
349 int k = n / (ns2*ns3);
350 if (k > kmax)
continue;
351 int j = (n - k*(ns2*ns3)) / ns3 + joff;
352 int i = n - k*(ns2*ns3) - (j-joff) * ns3 + ioff;
353 fab_arr(i,j,k,0) =
static_cast<DType
>(*(nc_arrays[iv].get_data()+n));
365 template<
class FAB,
typename DType>
368 const std::string &fname,
369 amrex::Vector<std::string> nc_var_names,
370 amrex::Vector<enum NC_Data_Dims_Type> NC_dim_types,
371 amrex::Vector<FAB*> fab_vars,
372 amrex::Vector<int>& success)
374 int ioproc = amrex::ParallelDescriptor::IOProcessorNumber();
376 amrex::Vector<NDArray<float>> nc_arrays(nc_var_names.size());
378 if (amrex::ParallelDescriptor::IOProcessor())
383 amrex::ParallelDescriptor::Bcast(success.dataPtr(), success.size(), ioproc);
385 for (
int iv = 0; iv < nc_var_names.size(); iv++)
387 if (success[iv] == 1) {
389 if (amrex::ParallelDescriptor::IOProcessor()) {
390 fill_fab_from_arrays<FAB,DType>(iv, domain, nc_arrays, nc_var_names[iv], NC_dim_types[iv], tmp);
393 int ncomp = tmp.nComp();
394 amrex::Box box = tmp.box();
396 amrex::ParallelDescriptor::Bcast(&box, 1, ioproc);
397 amrex::ParallelDescriptor::Bcast(&ncomp, 1, ioproc);
399 if (!amrex::ParallelDescriptor::IOProcessor()) {
401 tmp.resize(box,ncomp,amrex::The_Pinned_Arena());
403 tmp.resize(box,ncomp);
407 amrex::ParallelDescriptor::Bcast(tmp.dataPtr(), tmp.size(), ioproc);
410 amrex::Box fab_bx = tmp.box();
411 amrex::Dim3 dom_lb = lbound(domain);
412 fab_bx += amrex::IntVect(dom_lb.x,dom_lb.y,dom_lb.z);
414 fab_vars[iv]->resize(fab_bx,1);
416 amrex::Gpu::copy(amrex::Gpu::hostToDevice,
417 tmp.dataPtr(), tmp.dataPtr() + tmp.size(),
418 fab_vars[iv]->dataPtr());
421 fab_vars[iv]->copy(tmp,tmp.box(),0,fab_bx,0,1);
@ num
Definition: ERF_DataStruct.H:22
void ReadNetCDFFile(const std::string &fname, amrex::Vector< std::string > names, amrex::Vector< NDArray< DType > > &arrays, amrex::Vector< int > &success)
Definition: ERF_NCWpsFile.H:180
NC_Data_Dims_Type
Definition: ERF_NCWpsFile.H:29
void fill_fab_from_arrays(int iv, const amrex::Box &domain, amrex::Vector< NDArray< float >> &nc_arrays, const std::string &var_name, NC_Data_Dims_Type &NC_dim_type, FAB &temp)
Definition: ERF_NCWpsFile.H:266
void BuildFABsFromNetCDFFile(const amrex::Box &domain, const std::string &fname, amrex::Vector< std::string > nc_var_names, amrex::Vector< enum NC_Data_Dims_Type > NC_dim_types, amrex::Vector< FAB * > fab_vars, amrex::Vector< int > &success)
Definition: ERF_NCWpsFile.H:367
amrex::Vector< amrex::FArrayBox > PlaneVector
Definition: ERF_NCWpsFile.H:13
int BuildFABsFromWRFBdyFile(const std::string &fname, amrex::Vector< amrex::Vector< amrex::FArrayBox >> &bdy_data_xlo, amrex::Vector< amrex::Vector< amrex::FArrayBox >> &bdy_data_xhi, amrex::Vector< amrex::Vector< amrex::FArrayBox >> &bdy_data_ylo, amrex::Vector< amrex::Vector< amrex::FArrayBox >> &bdy_data_yhi)
void ReadTimeSliceFromNetCDFFile(const std::string &fname, const int tidx, amrex::Vector< std::string > names, amrex::Vector< NDArray< DType > > &arrays, amrex::Vector< int > &success)
Definition: ERF_NCWpsFile.H:133
static NCFile open(const std::string &name, const int cmode=NC_NOWRITE)
Definition: ERF_NCInterface.cpp:707
Definition: ERF_NCWpsFile.H:52
bool owned
Definition: ERF_NCWpsFile.H:122
std::string name
Definition: ERF_NCWpsFile.H:119
size_t ndim()
Definition: ERF_NCWpsFile.H:106
NDArray()
Definition: ERF_NCWpsFile.H:62
std::string get_vname()
Definition: ERF_NCWpsFile.H:96
NDArray(const NDArray &array)
Definition: ERF_NCWpsFile.H:65
NDArray & operator=(const NDArray &array)
Definition: ERF_NCWpsFile.H:74
void set_vshape(std::vector< size_t > vshape)
Definition: ERF_NCWpsFile.H:114
NDArray(const std::string vname, const std::vector< size_t > &vshape)
Definition: ERF_NCWpsFile.H:56
std::atomic< size_t > ref_counted
Definition: ERF_NCWpsFile.H:121
typename std::remove_const< DataType >::type DType
Definition: ERF_NCWpsFile.H:53
std::vector< size_t > shape
Definition: ERF_NCWpsFile.H:120
DType * data
Definition: ERF_NCWpsFile.H:123
decltype(auto) get_data()
Definition: ERF_NCWpsFile.H:90
std::vector< size_t > get_vshape()
Definition: ERF_NCWpsFile.H:101
~NDArray()
Definition: ERF_NCWpsFile.H:84