OOPS
LETKFSolver.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 
9 #ifndef OOPS_ASSIMILATION_LETKFSOLVER_H_
10 #define OOPS_ASSIMILATION_LETKFSOLVER_H_
11 
12 #include <Eigen/Dense>
13 #include <cfloat>
14 #include <memory>
15 #include <string>
16 #include <vector>
17 
18 #include "eckit/config/LocalConfiguration.h"
21 #include "oops/base/Departures.h"
23 #include "oops/base/Geometry.h"
26 #include "oops/base/ObsErrors.h"
28 #include "oops/base/ObsSpaces.h"
30 #include "oops/util/Logger.h"
31 #include "oops/util/Timer.h"
32 
33 namespace oops {
34 
35 /// Local Ensemble Tranform Kalman Filter solver
36 /*!
37  * An implementation of the LETKF from Hunt et al. 2007
38  * this version is implemented using Eigen algebra and
39  * temporary Eigen matrices for Xa and Xb
40  * this verion implements RTPP and RTPS.
41  *
42  * Hunt, B. R., Kostelich, E. J., & Szunyogh, I. (2007). Efficient data
43  * assimilation for spatiotemporal chaos: A local ensemble transform Kalman
44  * filter. Physica D: Nonlinear Phenomena, 230(1-2), 112-126.
45  */
46 template <typename MODEL, typename OBS>
47 class LETKFSolver : public LocalEnsembleSolver<MODEL, OBS> {
57 
58  public:
59  static const std::string classname() {return "oops::LETKFSolver";}
60 
61  LETKFSolver(ObsSpaces_ &, const Geometry_ &, const eckit::Configuration &, size_t,
62  const State4D_ &);
63 
64  /// KF update + posterior inflation at a grid point location (GeometryIterator_)
66  const GeometryIterator_ &, IncrementEnsemble4D_ &) override;
67 
68  protected:
69  /// Computes weights for ensemble update with local observations
70  /// \param[in] omb Observation departures (nlocalobs)
71  /// \param[in] Yb Ensemble perturbations (nens, nlocalobs)
72  /// \param[in] invvarR Inverse of observation error variances (nlocalobs)
73  virtual void computeWeights(const Eigen::VectorXd & omb, const Eigen::MatrixXd & Yb,
74  const Eigen::VectorXd & invvarR);
75 
76  /// Applies weights and adds posterior inflation
78  const GeometryIterator_ &);
79 
81 
82  Eigen::MatrixXd Wa_; // transformation matrix for ens. perts. Xa=Xf*Wa
83  Eigen::VectorXd wa_; // transformation matrix for ens. mean xa=xf*wa
84 
85  // eigen solver matrices
86  Eigen::VectorXd eival_;
87  Eigen::MatrixXd eivec_;
88 
89  const size_t nens_; // ensemble size
90 };
91 
92 // -----------------------------------------------------------------------------
93 
94 template <typename MODEL, typename OBS>
96  const eckit::Configuration & config, size_t nens,
97  const State4D_ & xbmean)
98  : LocalEnsembleSolver<MODEL, OBS>(obspaces, geometry, config, nens, xbmean),
99  nens_(nens)
100 {
101  options_.deserialize(config);
102  const LETKFInflationParameters & inflopt = options_.infl;
103 
104  Log::info() << "Using EIGEN implementation of LETKF" << std::endl;
105 
106  Log::info() << "Multiplicative inflation multCoeff=" <<
107  inflopt.mult << std::endl;
108 
109  if (inflopt.dortpp()) {
110  Log::info() << "RTPP inflation will be applied with rtppCoeff=" <<
111  inflopt.rtpp << std::endl;
112  } else {
113  Log::info() << "RTPP inflation is not applied rtppCoeff is out of bounds (0,1], rtppCoeff="
114  << inflopt.rtpp << std::endl;
115  }
116 
117  if (inflopt.dortps()) {
118  Log::info() << "RTPS inflation will be applied with rtpsCoeff=" <<
119  inflopt.rtps << std::endl;
120  } else {
121  Log::info() << "RTPS inflation is not applied rtpsCoeff is out of bounds (0,1], rtpsCoeff="
122  << inflopt.rtps << std::endl;
123  }
124 
125  // pre-allocate transformation matrices
126  Wa_.resize(nens_, nens_);
127  wa_.resize(nens_);
128 
129  // pre-allocate eigen sovler matrices
130  eival_.resize(nens_);
131  eivec_.resize(nens_, nens_);
132 }
133 
134 // -----------------------------------------------------------------------------
135 
136 template <typename MODEL, typename OBS>
138  const GeometryIterator_ & i,
139  IncrementEnsemble4D_ & ana_pert) {
140  util::Timer timer(classname(), "measurementUpdate");
141 
142  // create the local subset of observations
143  Departures_ locvector(this->obspaces_);
144  locvector.ones();
145  this->obsloc().computeLocalization(i, locvector);
146  locvector.mask(*(this->invVarR_));
147  Eigen::VectorXd local_omb_vec = this->omb_.packEigen(locvector);
148 
149  if (local_omb_vec.size() == 0) {
150  // no obs. so no need to update Wa_ and wa_
151  // ana_pert[i]=bkg_pert[i]
152  this->copyLocalIncrement(bkg_pert, i, ana_pert);
153  } else {
154  // if obs are present do normal KF update
155  // create local Yb
156  Eigen::MatrixXd local_Yb_mat = this->Yb_.packEigen(locvector);
157  // create local obs errors
158  Eigen::VectorXd local_invVarR_vec = this->invVarR_->packEigen(locvector);
159  // and apply localization
160  Eigen::VectorXd localization = locvector.packEigen(locvector);
161  local_invVarR_vec.array() *= localization.array();
162  computeWeights(local_omb_vec, local_Yb_mat, local_invVarR_vec);
163  applyWeights(bkg_pert, ana_pert, i);
164  }
165 }
166 
167 // -----------------------------------------------------------------------------
168 
169 template <typename MODEL, typename OBS>
170 void LETKFSolver<MODEL, OBS>::computeWeights(const Eigen::VectorXd & dy,
171  const Eigen::MatrixXd & Yb,
172  const Eigen::VectorXd & diagInvR ) {
173  // compute transformation matrix, save in Wa_, wa_
174  // uses C++ eigen interface
175  // implements LETKF from Hunt et al. 2007
176  util::Timer timer(classname(), "computeWeights");
177 
178  const LETKFInflationParameters & inflopt = options_.infl;
179 
180  // fill in the work matrix
181  // work = Y^T R^-1 Y + (nens-1)/infl I
182  double infl = inflopt.mult;
183  Eigen::MatrixXd work = Yb*(diagInvR.asDiagonal()*Yb.transpose());
184  work.diagonal() += Eigen::VectorXd::Constant(nens_, (nens_-1)/infl);
185 
186  // eigenvalues and eigenvectors of the above matrix
187  Eigen::SelfAdjointEigenSolver<Eigen::MatrixXd> es(work);
188  eival_ = es.eigenvalues().real();
189  eivec_ = es.eigenvectors().real();
190 
191  // Pa = [ Yb^T R^-1 Yb + (nens-1)/infl I ] ^-1
192  work = eivec_ * eival_.cwiseInverse().asDiagonal() * eivec_.transpose();
193 
194  // Wa = sqrt[ (nens-1) Pa ]
195  Wa_ = eivec_
196  * ((nens_-1) * eival_.array().inverse()).sqrt().matrix().asDiagonal()
197  * eivec_.transpose();
198 
199  // wa = Pa Yb^T R^-1 dy
200  wa_ = work * (Yb * (diagInvR.asDiagonal()*dy));
201 }
202 
203 // -----------------------------------------------------------------------------
204 
205 template <typename MODEL, typename OBS>
207  IncrementEnsemble4D_ & ana_pert,
208  const GeometryIterator_ & i) {
209  // applies Wa_, wa_
210  util::Timer timer(classname(), "applyWeights");
211 
212  const LETKFInflationParameters & inflopt = options_.infl;
213 
214  LocalIncrement gptmpl = bkg_pert[0][0].getLocal(i);
215  std::vector<double> tmp1 = gptmpl.getVals();
216  size_t ngp = tmp1.size();
217 
218  // loop through analysis times and ens. members
219  for (size_t itime=0; itime < bkg_pert[0].size(); ++itime) {
220  // make grid point forecast pert ensemble array
221  Eigen::MatrixXd Xb(ngp, nens_);
222  // #pragma omp parallel for
223  for (size_t iens=0; iens < nens_; ++iens) {
224  LocalIncrement gp = bkg_pert[iens][itime].getLocal(i);
225  std::vector<double> tmp = gp.getVals();
226  for (size_t iv=0; iv < ngp; ++iv) {
227  Xb(iv, iens) = tmp[iv];
228  }
229  }
230 
231  // postmulptiply
232  Eigen::VectorXd xa = Xb*wa_; // ensemble mean update
233  Eigen::MatrixXd Xa = Xb*Wa_; // ensemble perturbation update
234 
235  // RTPP inflation
236  if (inflopt.dortpp()) {
237  Xa = (1-inflopt.rtpp)*Xa+inflopt.rtpp*Xb;
238  }
239 
240  // RTPS inflation
241  double eps = DBL_EPSILON;
242  if (inflopt.dortps()) {
243  // posterior spread
244  Eigen::ArrayXd asprd = Xa.array().square().rowwise().sum()/(nens_-1);
245  asprd = asprd.sqrt();
246  asprd = (asprd < eps).select(eps, asprd); // avoid nan overflow for vars with no spread
247 
248  // prior spread
249  Eigen::ArrayXd fsprd = Xb.array().square().rowwise().sum()/(nens_-1);
250  fsprd = fsprd.sqrt();
251  fsprd = (fsprd < eps).select(eps, fsprd);
252 
253  // rtps inflation factor
254  Eigen::ArrayXd rtpsInfl = inflopt.rtps*((fsprd-asprd)/asprd) + 1;
255  rtpsInfl = (rtpsInfl < inflopt.rtpsInflMin()).select(inflopt.rtpsInflMin(), rtpsInfl);
256  rtpsInfl = (rtpsInfl > inflopt.rtpsInflMax()).select(inflopt.rtpsInflMax(), rtpsInfl);
257 
258  // inlfate perturbation matrix
259  Xa.array().colwise() *= rtpsInfl;
260  }
261 
262  // assign Xa to ana_pert
263  // #pragma omp parallel for private(tmp1)
264  for (size_t iens=0; iens < nens_; ++iens) {
265  for (size_t iv=0; iv < ngp; ++iv) {
266  tmp1[iv] = Xa(iv, iens)+xa(iv); // if Xa = Xb*Wa;
267  }
268  gptmpl.setVals(tmp1);
269  ana_pert[iens][itime].setLocal(gptmpl, i);
270  }
271  }
272 }
273 
274 // -----------------------------------------------------------------------------
275 
276 } // namespace oops
277 #endif // OOPS_ASSIMILATION_LETKFSOLVER_H_
Ensemble of Departures (can hold ensemble perturbations in the observation space)
Difference between two observation vectors.
Definition: Departures.h:44
void mask(ObsDataVec_< int >)
Mask out departures where the passed in qc flags are > 0.
Definition: Departures.h:209
Eigen::VectorXd packEigen(const Departures &) const
Pack departures in an Eigen vector (excluding departures that are masked out)
Definition: Departures.h:223
Geometry class used in oops; subclass of interface class interface::Geometry.
Ensemble of 4D increments.
size_t size() const
Accessors.
Parameters for LETKF inflation.
Local Ensemble Tranform Kalman Filter solver.
Definition: LETKFSolver.h:47
Departures< OBS > Departures_
Definition: LETKFSolver.h:48
const size_t nens_
Definition: LETKFSolver.h:89
void measurementUpdate(const IncrementEnsemble4D_ &, const GeometryIterator_ &, IncrementEnsemble4D_ &) override
KF update + posterior inflation at a grid point location (GeometryIterator_)
Definition: LETKFSolver.h:137
ObsLocalizations< MODEL, OBS > ObsLocalizations_
Definition: LETKFSolver.h:54
LETKFSolver(ObsSpaces_ &, const Geometry_ &, const eckit::Configuration &, size_t, const State4D_ &)
Definition: LETKFSolver.h:95
Eigen::VectorXd wa_
Definition: LETKFSolver.h:83
State4D< MODEL > State4D_
Definition: LETKFSolver.h:56
LETKFSolverParameters options_
Definition: LETKFSolver.h:80
Geometry< MODEL > Geometry_
Definition: LETKFSolver.h:50
IncrementEnsemble4D< MODEL > IncrementEnsemble4D_
Definition: LETKFSolver.h:52
DeparturesEnsemble< OBS > DeparturesEnsemble_
Definition: LETKFSolver.h:49
ObsErrors< OBS > ObsErrors_
Definition: LETKFSolver.h:53
virtual void applyWeights(const IncrementEnsemble4D_ &, IncrementEnsemble4D_ &, const GeometryIterator_ &)
Applies weights and adds posterior inflation.
Definition: LETKFSolver.h:206
Eigen::VectorXd eival_
Definition: LETKFSolver.h:86
virtual void computeWeights(const Eigen::VectorXd &omb, const Eigen::MatrixXd &Yb, const Eigen::VectorXd &invvarR)
Definition: LETKFSolver.h:170
GeometryIterator< MODEL > GeometryIterator_
Definition: LETKFSolver.h:51
ObsSpaces< OBS > ObsSpaces_
Definition: LETKFSolver.h:55
Eigen::MatrixXd Wa_
Definition: LETKFSolver.h:82
static const std::string classname()
Definition: LETKFSolver.h:59
Eigen::MatrixXd eivec_
Definition: LETKFSolver.h:87
Parameter< LETKFInflationParameters > infl
Base class for LETKF-type solvers.
void setVals(std::vector< double > &)
const std::vector< double > & getVals() const
Container for ObsErrors for all observation types that are used in DA.
Definition: ObsErrors.h:34
Container for ObsLocalizations for all observation types that are used in DA.
Four dimensional state (vector of 3D States)
Definition: State4D.h:29
The namespace for the main oops code.