OOPS
oops/generic/VerticalLocEV.h
Go to the documentation of this file.
1 /*
2  * (C) Copyright 2020 UCAR
3  *
4  * This software is licensed under the terms of the Apache Licence Version 2.0
5  * which can be obtained at http://www.apache.org/licenses/LICENSE-2.0.
6  */
7 
8 #ifndef OOPS_GENERIC_VERTICALLOCEV_H_
9 #define OOPS_GENERIC_VERTICALLOCEV_H_
10 
11 #include <Eigen/Dense>
12 
13 #include <memory>
14 #include <string>
15 #include <vector>
16 
17 #include "eckit/config/Configuration.h"
18 
19 #include "oops/base/Geometry.h"
20 #include "oops/base/Increment4D.h"
24 #include "oops/generic/gc99.h"
27 #include "oops/util/Logger.h"
28 #include "oops/util/ObjectCounter.h"
29 #include "oops/util/parameters/Parameter.h"
30 #include "oops/util/parameters/Parameters.h"
31 #include "oops/util/parameters/RequiredParameter.h"
32 #include "oops/util/Printable.h"
33 
34 namespace oops {
35 
36 /// Parameters for vertical localization
37 /*!
38  * See Lei 2018 JAMES for more details
39  *
40  * Lei, L., Whitaker, J. S., & Bishop, C. ( 2018). Improving assimilation
41  * of radiance observations by implementing model space localization in an
42  * ensemble Kalman filter. Journal of Advances in Modeling Earth Systems, 10,
43  * 3221– 3232. https://doi.org/10.1029/2018MS001468
44  */
45 class VerticalLocalizationParameters : public Parameters {
46  OOPS_CONCRETE_PARAMETERS(VerticalLocalizationParameters, Parameters)
47  public:
48  // fraction of the variance retained after the eigen spectrum
49  // of the vertical localization function is truncated
50  // 1 -- retain all eigen vectors
51  // 0 -- retain the first eigen vector
52  Parameter<double> VertLocToll{"fraction of retained variance", 1.0, this};
53  // localization distance at which Gaspari-Cohn = 0
54  RequiredParameter<double> VertLocDist{"lengthscale", this};
55  // localization distance at which Gaspari-Cohn = 0
56  RequiredParameter<std::string> VertLocUnits{"lengthscale units", this};
57  // write eigen vectors to disk
58  Parameter<bool> writeEVs{"write eigen vectors", false, this};
59  // read eigen vectors from disk
60  Parameter<bool> readEVs{"read eigen vectors", false, this};
61 };
62 
63 // ----------------------------------------------------------------------------
64 template<typename MODEL>
65 class VerticalLocEV: public util::Printable,
66  private util::ObjectCounter<VerticalLocEV<MODEL>> {
74 
75  public:
76  static const std::string classname() {return "oops::VerticalLocEV";}
77 
78  VerticalLocEV(const eckit::Configuration &, const State_ &);
79 
80 // modulate an increment
82 
83 // modulate an incrementEnsemble at a {gridPoint, timeSlice}
84  Eigen::MatrixXd modulateIncrement(const IncrementEnsemble4D_ &,
85  const GeometryIterator_ &, size_t) const;
86 
87 // returns number of retained eigen modes
88  size_t neig() const {return neig_;}
89 
90 // tests if the truncation and rescaling are done properly
91  bool testTruncateEvecs(const Geometry_ &);
92 
93  private:
94 // compute vertical correlations and eigen vectors
95  Eigen::MatrixXd computeCorrMatrix(const Geometry_ &);
96  void computeCorrMatrixEvec(const Eigen::MatrixXd &);
97 
98 // truncate Evec sequence
99  size_t truncateEvecs();
100 
101 // replicate eigen vectors for state vars
102  std::vector<double> replicateEigenVector(const oops::Variables &,
103  size_t) const;
104 
105 // populate 3D increment array of eigen vectors
107 // IO for eigen vectors
108  void writeEVsToDisk(const eckit::Configuration &) const;
109  void readEVsFromDisk(const Geometry_ &, const Variables &, const util::DateTime &,
110  const eckit::Configuration &);
111 
112  private:
113  void print(std::ostream &) const {}
115  Eigen::MatrixXd Evecs_;
116  Eigen::VectorXd Evals_;
117  size_t neig_;
118  std::unique_ptr<IncrementEnsemble_> sqrtVertLoc_;
119  // if true store EVs as explicit 3D fields
120  // TODO(frolovsa) depriciate 1D storage in the future
121  // once we see no issues with always using 3D
122  bool EVsStoredAs3D_ = true; // if true store EVs as explicit 3D fields
123 };
124 // -----------------------------------------------------------------------------
125 template<typename MODEL>
126  VerticalLocEV<MODEL>::VerticalLocEV(const eckit::Configuration & conf,
127  const State_ & x): sqrtVertLoc_() {
128  // read vertical localization configuration
129  options_.deserialize(conf);
130 
131  if (options_.readEVs) {
132  oops::Log::info() << "Reading precomputed vertical localization EVs from disk" << std::endl;
133  readEVsFromDisk(x.geometry(), x.variables(), x.validTime(), conf);
134  neig_ = sqrtVertLoc_->size();
135  } else {
136  oops::Log::info() << "Computing vertical localization EVs from scratch" << std::endl;
137  // compute vertical corrleation matrix fo nLevs
138  Eigen::MatrixXd cov = computeCorrMatrix(x.geometry());
139  // compute truncated correlation matrix
141  neig_ = truncateEvecs();
142  // convert EVs to 3D if needed
143  if (EVsStoredAs3D_) {
144  sqrtVertLoc_ = boost::make_unique<IncrementEnsemble_>
145  (x.geometry(), x.variables(), x.validTime(), neig_);
147  }
148  }
149 
150  if (options_.writeEVs) { writeEVsToDisk(conf); }
151  }
152 
153 // -----------------------------------------------------------------------------
154 template<typename MODEL>
156  const Geometry_ & geom = (*sqrtVertLoc_)[0].geometry();
157  for (size_t ieig=0; ieig < neig_; ++ieig) {
158  std::vector<double> EvecRepl = replicateEigenVector(vars, ieig);
159  (*sqrtVertLoc_)[ieig].ones();
160  for (GeometryIterator_ gpi = geom.begin(); gpi != geom.end(); ++gpi) {
161  oops::LocalIncrement gp = (*sqrtVertLoc_)[ieig].getLocal(gpi);
162  gp *= EvecRepl;
163  (*sqrtVertLoc_)[ieig].setLocal(gp, gpi);
164  }
165  }
166  }
167 
168 // -----------------------------------------------------------------------------
169 template<typename MODEL>
170  void VerticalLocEV<MODEL>::writeEVsToDisk(const eckit::Configuration & config) const {
171  eckit::LocalConfiguration outConfig(config, "list of eigen vectors to write");
172  sqrtVertLoc_->write(outConfig);
173  }
174 
175 // -----------------------------------------------------------------------------
176 template<typename MODEL>
178  const util::DateTime & tslot,
179  const eckit::Configuration & config) {
180  std::vector<eckit::LocalConfiguration> memberConfig;
181  config.get("list of eigen vectors to read", memberConfig);
182  sqrtVertLoc_ = boost::make_unique<IncrementEnsemble_>(geom, vars, tslot, memberConfig.size());
183 
184  // Loop over all ensemble members
185  for (size_t jj = 0; jj < memberConfig.size(); ++jj) {
186  (*sqrtVertLoc_)[jj].read(memberConfig[jj]);
187  }
188  }
189 
190 // -------------------------------------------------------------------------------------------------
191 template<typename MODEL>
192  Eigen::MatrixXd VerticalLocEV<MODEL>::computeCorrMatrix(const Geometry_ & geom) {
193  std::string locUnits = options_.VertLocUnits;
194  oops::Log::debug() << "locUnits: " << locUnits << std::endl;
195  std::vector<double> vCoord = geom.verticalCoord(locUnits);
196  size_t nlevs = vCoord.size();
197 
198  // compute vertical correlations and eigen vectors
199  Eigen::MatrixXd cov = Eigen::MatrixXd::Zero(nlevs, nlevs);
200  for (size_t jj=0; jj < nlevs; ++jj) {
201  for (size_t ii=jj; ii < nlevs; ++ii) {
202  cov(ii, jj) = oops::gc99(std::abs(vCoord[jj]-vCoord[ii])/options_.VertLocDist);
203  }
204  }
205  oops::Log::debug() << "corr: " << cov << std::endl;
206 
207  return cov;
208  }
209 
210 
211 // -------------------------------------------------------------------------------------------------
212 template<typename MODEL>
213  void VerticalLocEV<MODEL>::computeCorrMatrixEvec(const Eigen::MatrixXd & cov) {
214  // compute eigen decomposition of vertical correlation matrix
215  Eigen::SelfAdjointEigenSolver<Eigen::MatrixXd> es(cov);
216  Evals_ = es.eigenvalues().real();
217  Evecs_ = es.eigenvectors().real();
218 
219  // reverse order, largest eigen value first.
220  Evals_.reverseInPlace();
221  Evecs_.rowwise().reverseInPlace();
222  }
223 
224 // -------------------------------------------------------------------------------------------------
225 template<typename MODEL>
227  // truncate Evec sequence to retain "toll" percetage of total variance
228  double evalsum = Evals_.sum();
229 
230  // assert condition on the trace of the correlation matrix
231  if ((evalsum-Evals_.size()) > 1e-5) {
232  Log::error() << "VerticalLocEV trace(cov)~=cov.size: trace(cov)=" <<
233  evalsum << "cov.size=" << Evals_.size() << std::endl;
234  throw eckit::BadValue("VerticalLocEV trace(cov)~=cov.size");
235  }
236 
237  // compute number of evals bellow tolerence
238  double frac = 0.0;
239  size_t neig = 0;
240  for (int ii=0; ii < Evals_.size(); ++ii) {
241  frac += Evals_[ii];
242  neig += 1;
243  if (frac/evalsum >= options_.VertLocToll) { break; }
244  }
245  frac = frac/evalsum;
246 
247  oops::Log::info() << "Retaining frac: " << frac << std::endl;
248  oops::Log::info() << "Retaining neig vectors in vert. loc.: " << neig << std::endl;
249 
250  // compute Eivec(:,i)=Eivec(:,i)*sqrt(Evals(i)/frac)
251  // i.e. make Evecs_=sgrt(cov)
252  Evals_.array() *= 1/frac;
253  for (int ii=0; ii < Evals_.size(); ++ii) {
254  Evecs_.array().col(ii) *= std::sqrt(Evals_(ii));
255  }
256 
257  // truncate to keep neig
258  Evecs_.conservativeResize(Eigen::NoChange, neig);
259  Evals_.conservativeResize(neig);
260 
261  // assert that the trace of the new and old cov is the same
262  if ((evalsum-Evals_.sum()) > 1e-5) {
263  Log::error() << "VerticalLocEV::truncateEvecs trace(cov)~=trace(covTrunc): " <<
264  " trace(cov)=" << evalsum << " trace(covTrunc)=" << Evals_.sum() <<
265  " diff=" << (evalsum-Evals_.sum()) << std::endl;
266  throw eckit::BadValue("VerticalLocEV::truncateEvecs trace(cov)~=trace(covTrunc)");
267  }
268 
269  // return number of truncated eigen values
270  return neig;
271  }
272 
273 
274 // -----------------------------------------------------------------------------
275 template<typename MODEL>
277  // only do this test if we are computing EVs from scratch
278  // if reading from disk return true
279  if (options_.readEVs) {return true;}
280 
281  // make reference solution
282  Eigen::MatrixXd cov = computeCorrMatrix(geom);
283  // only the lower traingle of cov is stored
284  // transform to full matrix
285  Eigen::MatrixXd covOld = cov+cov.transpose();
286  covOld.diagonal() = covOld.diagonal()/2;
287 
288  // recreate covNew from stored Evecs
289  Eigen::MatrixXd covNew = Evecs_*Evecs_.transpose();
290 
291  oops::Log::debug() << "Trace covNew " << covNew.diagonal().sum() << std::endl;
292  oops::Log::debug() << "Trace cov " << covOld.diagonal().sum() << std::endl;
293 
294  oops::Log::debug() << "norm(covNew) " << covNew.norm() << std::endl;
295  oops::Log::debug() << "norm(cov) " << covOld.norm() << std::endl;
296 
297  covNew = covNew.array() - covOld.array();
298  oops::Log::debug() << "norm(covNew-cov) " << covNew.norm() << std::endl;
299 
300  bool rv = (covNew.diagonal().sum() - cov.diagonal().sum()) < 1e-5;
301  return rv;
302 }
303 
304 // -----------------------------------------------------------------------------
305 template<typename MODEL>
307  IncrementEnsemble4D_ & incrsOut) const {
308  // modulate an increment incr using Eivec_
309  // returns incrsOut
310 
311  // create temporary vector that would be used to store the full
312  // eigen vector of the correlation matrix
313  // at this point Evecs_ stores eigen vector.size()=nLevs
314  // we need nLevs*nVars
315  // TODO(Issue #812) catch a special case where some variables in the gp are not 3D
316  // consider doing it once instead of replicating this for each gp (Issue #813)
317  oops::Variables vars = incr[0].variables();
318 
319  for (size_t ieig=0; ieig < neig_; ++ieig) {
320  // modulate an increment
321  for (size_t itime=0; itime < incr.size(); ++itime) {
322  if (EVsStoredAs3D_) { // if EVs stored as 3D use oops operation for schur_product
323  incrsOut[ieig][itime] = (*sqrtVertLoc_)[ieig];
324  incrsOut[ieig][itime].schur_product_with(incr[itime]);
325  } else { // if EV is only available as a 1D column use grid eterator
326  std::vector<double> EvecRepl = replicateEigenVector(vars, ieig);
327  const Geometry_ & geom = incr[itime].geometry();
328  for (GeometryIterator_ gpi = geom.begin(); gpi != geom.end(); ++gpi) {
329  oops::LocalIncrement gp = incr[itime].getLocal(gpi);
330  gp *= EvecRepl;
331  incrsOut[ieig][itime].setLocal(gp, gpi);
332  }
333  }
334  }
335  }
336 }
337 
338 // -----------------------------------------------------------------------------
339 template<typename MODEL>
341  const IncrementEnsemble4D_ & incrs,
342  const GeometryIterator_ & gi,
343  size_t itime) const {
344  // modulate an increment at grid point
345 
346  oops::Variables vars = incrs[0][0].variables();
347  size_t nv = 0;
348  std::vector<double> EvecRepl;
349  if (EVsStoredAs3D_) {
350  nv = (*sqrtVertLoc_)[0].getLocal(gi).getVals().size();
351  } else {
352  EvecRepl = replicateEigenVector(vars, 0);
353  nv = EvecRepl.size();
354  }
355  size_t nens = incrs.size();
356  Eigen::MatrixXd Z(nv, neig_*nens);
357  std::vector<double> etmp2(nv);
358 
359  size_t ii = 0;
360  for (size_t iens=0; iens < nens; ++iens) {
361  etmp2 = incrs[iens][itime].getLocal(gi).getVals();
362  for (size_t ieig=0; ieig < neig_; ++ieig) {
363  if (EVsStoredAs3D_) {
364  EvecRepl = (*sqrtVertLoc_)[ieig].getLocal(gi).getVals();
365  } else {
366  EvecRepl = replicateEigenVector(vars, ieig);
367  }
368  // modulate and assign
369  for (size_t iv=0; iv < nv; ++iv) {
370  Z(iv, ii) = EvecRepl[iv]*etmp2[iv];
371  }
372  ii += 1;
373  }
374  }
375  return Z;
376 }
377 
378 // -----------------------------------------------------------------------------
379 template<typename MODEL>
381  const oops::Variables & v, size_t ieig) const {
382  // populate eigen vector for all variables nLevs*nVars
383  std::vector<double> etmp(Evecs_.rows()*v.size());
384 
385  size_t ii = 0;
386  for (unsigned ivar=0; ivar < v.size(); ++ivar) {
387  for (unsigned ilev=0; ilev < Evecs_.rows(); ++ilev) {
388  etmp[ii] = Evecs_(ilev, ieig);
389  ii += 1;
390  }
391  }
392  return etmp;
393 }
394 
395 } // namespace oops
396 
397 #endif // OOPS_GENERIC_VERTICALLOCEV_H_
Geometry class used in oops; subclass of interface class interface::Geometry.
4D model state Increment (vector of 3D Increments)
Definition: Increment4D.h:32
Geometry_ geometry() const
Get geometry.
Definition: Increment4D.h:52
size_t size() const
Definition: Increment4D.h:57
Ensemble of 4D increments.
size_t size() const
Accessors.
Ensemble of inrements.
Increment class used in oops.
State class used in oops; subclass of interface class interface::State.
size_t size() const
std::vector< double > replicateEigenVector(const oops::Variables &, size_t) const
Increment4D< MODEL > Increment4D_
Eigen::MatrixXd computeCorrMatrix(const Geometry_ &)
void writeEVsToDisk(const eckit::Configuration &) const
VerticalLocalizationParameters options_
void print(std::ostream &) const
void readEVsFromDisk(const Geometry_ &, const Variables &, const util::DateTime &, const eckit::Configuration &)
void computeCorrMatrixEvec(const Eigen::MatrixXd &)
std::unique_ptr< IncrementEnsemble_ > sqrtVertLoc_
GeometryIterator< MODEL > GeometryIterator_
IncrementEnsemble4D< MODEL > IncrementEnsemble4D_
void modulateIncrement(const Increment4D_ &, IncrementEnsemble4D_ &) const
static const std::string classname()
IncrementEnsemble< MODEL > IncrementEnsemble_
VerticalLocEV(const eckit::Configuration &, const State_ &)
bool testTruncateEvecs(const Geometry_ &)
void populateIncrementEnsembleWithEVs(const Variables &)
Parameters for vertical localization.
RequiredParameter< std::string > VertLocUnits
GeometryIterator_ end() const
Iterator to the past-the-end gridpoint of Geometry (only used in LocalEnsembleDA)
std::vector< double > verticalCoord(std::string &) const
Values of vertical coordinate in units specified by string (only used in GETKF)
const Geometry_ & geometry() const
GeometryIterator_ begin() const
Iterator to the first gridpoint of Geometry (only used in LocalEnsembleDA)
Geometry_ geometry() const
Accessor to geometry associated with this State.
const util::DateTime validTime() const
Accessor to the time of this State.
const Variables & variables() const
Accessor to variables associated with this State.
int error
Definition: compare.py:168
The namespace for the main oops code.
double gc99(const double &distnorm)