diff --git a/bsl__predcorr__second__order__explicit_8hpp_source.html b/bsl__predcorr__second__order__explicit_8hpp_source.html index e089ea08d..e101434d3 100644 --- a/bsl__predcorr__second__order__explicit_8hpp_source.html +++ b/bsl__predcorr__second__order__explicit_8hpp_source.html @@ -176,170 +176,169 @@
133  }
134 
135 
-
136  ~BslExplicitPredCorrRTheta() {};
+
136  ~BslExplicitPredCorrRTheta() override {}
137 
138 
139 
-
140  host_t<DFieldRTheta> operator()(
+
140  host_t<DFieldRTheta> operator()(
141  host_t<DFieldRTheta> allfdistribu,
142  double const dt,
-
143  int const steps) const
-
144  {
-
145  std::chrono::time_point<std::chrono::system_clock> start_time
-
146  = std::chrono::system_clock::now();
-
147  std::chrono::time_point<std::chrono::system_clock> end_time;
-
148 
-
149  // Grid. ------------------------------------------------------------------------------------------
-
150  IdxRangeRTheta const grid(get_idx_range<GridR, GridTheta>(allfdistribu));
-
151 
-
152  host_t<FieldMemRTheta<CoordRTheta>> coords(grid);
-
153  ddc::for_each(grid, [&](IdxRTheta const irp) { coords(irp) = ddc::coordinate(irp); });
-
154 
-
155  IdxRangeBSR radial_bsplines(ddc::discrete_space<BSplinesR>().full_domain().remove_first(
-
156  IdxStep<BSplinesR> {PolarBSplinesRTheta::continuity + 1}));
-
157  IdxRangeBSTheta polar_idx_range(ddc::discrete_space<BSplinesTheta>().full_domain());
-
158 
-
159  // --- Electrostatic potential (phi). -------------------------------------------------------------
-
160  host_t<DFieldMemRTheta> electrical_potential(grid);
-
161 
-
162  SplinePolar electrostatic_potential_coef(
-
163  PolarBSplinesRTheta::singular_idx_range<PolarBSplinesRTheta>(),
-
164  IdxRangeBSRTheta(radial_bsplines, polar_idx_range));
-
165 
-
166  ddc::NullExtrapolationRule extrapolation_rule;
-
167  PolarSplineEvaluator<PolarBSplinesRTheta, ddc::NullExtrapolationRule>
-
168  polar_spline_evaluator(extrapolation_rule);
-
169 
-
170  // --- For the computation of advection field from the electrostatic potential (phi): -------------
-
171  host_t<DVectorFieldMemRTheta<X, Y>> electric_field_alloc(grid);
-
172  host_t<DVectorFieldMemRTheta<X, Y>> electric_field_predicted_alloc(grid);
-
173  host_t<DVectorFieldMemRTheta<X, Y>> advection_field_alloc(grid);
-
174  host_t<DVectorFieldMemRTheta<X, Y>> advection_field_predicted_alloc(grid);
-
175 
-
176  host_t<DVectorFieldRTheta<X, Y>> electric_field(electric_field_alloc);
-
177  host_t<DVectorFieldRTheta<X, Y>> electric_field_predicted(electric_field_predicted_alloc);
-
178  host_t<DVectorFieldRTheta<X, Y>> advection_field(advection_field_alloc);
-
179  host_t<DVectorFieldRTheta<X, Y>> advection_field_predicted(advection_field_predicted_alloc);
-
180 
-
181  AdvectionFieldFinder advection_field_computer(m_mapping);
+
143  int const steps) const final
+
144  {
+
145  std::chrono::time_point<std::chrono::system_clock> start_time;
+
146  std::chrono::time_point<std::chrono::system_clock> end_time;
+
147 
+
148  // Grid. ------------------------------------------------------------------------------------------
+
149  IdxRangeRTheta const grid(get_idx_range<GridR, GridTheta>(allfdistribu));
+
150 
+
151  host_t<FieldMemRTheta<CoordRTheta>> coords(grid);
+
152  ddc::for_each(grid, [&](IdxRTheta const irp) { coords(irp) = ddc::coordinate(irp); });
+
153 
+
154  IdxRangeBSR radial_bsplines(ddc::discrete_space<BSplinesR>().full_domain().remove_first(
+
155  IdxStep<BSplinesR> {PolarBSplinesRTheta::continuity + 1}));
+
156  IdxRangeBSTheta polar_idx_range(ddc::discrete_space<BSplinesTheta>().full_domain());
+
157 
+
158  // --- Electrostatic potential (phi). -------------------------------------------------------------
+
159  host_t<DFieldMemRTheta> electrical_potential(grid);
+
160 
+
161  SplinePolar electrostatic_potential_coef(
+
162  PolarBSplinesRTheta::singular_idx_range<PolarBSplinesRTheta>(),
+
163  IdxRangeBSRTheta(radial_bsplines, polar_idx_range));
+
164 
+
165  ddc::NullExtrapolationRule extrapolation_rule;
+
166  PolarSplineEvaluator<PolarBSplinesRTheta, ddc::NullExtrapolationRule>
+
167  polar_spline_evaluator(extrapolation_rule);
+
168 
+
169  // --- For the computation of advection field from the electrostatic potential (phi): -------------
+
170  host_t<DVectorFieldMemRTheta<X, Y>> electric_field_alloc(grid);
+
171  host_t<DVectorFieldMemRTheta<X, Y>> electric_field_predicted_alloc(grid);
+
172  host_t<DVectorFieldMemRTheta<X, Y>> advection_field_alloc(grid);
+
173  host_t<DVectorFieldMemRTheta<X, Y>> advection_field_predicted_alloc(grid);
+
174 
+
175  host_t<DVectorFieldRTheta<X, Y>> electric_field(electric_field_alloc);
+
176  host_t<DVectorFieldRTheta<X, Y>> electric_field_predicted(electric_field_predicted_alloc);
+
177  host_t<DVectorFieldRTheta<X, Y>> advection_field(advection_field_alloc);
+
178  host_t<DVectorFieldRTheta<X, Y>> advection_field_predicted(advection_field_predicted_alloc);
+
179 
+
180  AdvectionFieldFinder advection_field_computer(m_mapping);
+
181 
182 
183 
-
184 
-
185  // --- Parameter for linearisation of advection field: --------------------------------------------
-
186  start_time = std::chrono::system_clock::now();
-
187  for (int iter(0); iter < steps; ++iter) {
-
188  double const time = iter * dt;
-
189  // STEP 1: From rho^n, we compute phi^n: Poisson equation
-
190  host_t<Spline2DMem> allfdistribu_coef(get_spline_idx_range(m_builder));
-
191  m_builder(get_field(allfdistribu_coef), get_const_field(allfdistribu));
-
192  PoissonLikeRHSFunction const
-
193  charge_density_coord_1(get_const_field(allfdistribu_coef), m_evaluator);
-
194  m_poisson_solver(charge_density_coord_1, electrostatic_potential_coef);
-
195 
-
196  polar_spline_evaluator(
-
197  get_field(electrical_potential),
-
198  get_const_field(coords),
-
199  electrostatic_potential_coef);
-
200 
-
201  ddc::PdiEvent("iteration")
-
202  .with("iter", iter)
-
203  .and_with("time", time)
-
204  .and_with("density", allfdistribu)
-
205  .and_with("electrical_potential", electrical_potential);
-
206 
-
207  // STEP 2: From phi^n, we compute A^n:
-
208  advection_field_computer(electrostatic_potential_coef, advection_field);
+
184  // --- Parameter for linearisation of advection field: --------------------------------------------
+
185  start_time = std::chrono::system_clock::now();
+
186  for (int iter(0); iter < steps; ++iter) {
+
187  double const time = iter * dt;
+
188  // STEP 1: From rho^n, we compute phi^n: Poisson equation
+
189  host_t<Spline2DMem> allfdistribu_coef(get_spline_idx_range(m_builder));
+
190  m_builder(get_field(allfdistribu_coef), get_const_field(allfdistribu));
+
191  PoissonLikeRHSFunction const
+
192  charge_density_coord_1(get_const_field(allfdistribu_coef), m_evaluator);
+
193  m_poisson_solver(charge_density_coord_1, electrostatic_potential_coef);
+
194 
+
195  polar_spline_evaluator(
+
196  get_field(electrical_potential),
+
197  get_const_field(coords),
+
198  electrostatic_potential_coef);
+
199 
+
200  ddc::PdiEvent("iteration")
+
201  .with("iter", iter)
+
202  .and_with("time", time)
+
203  .and_with("density", allfdistribu)
+
204  .and_with("electrical_potential", electrical_potential);
+
205 
+
206  // STEP 2: From phi^n, we compute A^n:
+
207  advection_field_computer(electrostatic_potential_coef, advection_field);
+
208 
209 
-
210 
-
211  // STEP 3: From rho^n and A^n, we compute rho^P: Vlasov equation
-
212  // --- Copy rho^n because it will be modified:
-
213  host_t<DFieldMemRTheta> allfdistribu_predicted(grid);
-
214  ddc::parallel_deepcopy(get_field(allfdistribu_predicted), allfdistribu);
-
215  m_advection_solver(get_field(allfdistribu_predicted), get_field(advection_field), dt);
-
216 
-
217  // --- advect also the feet because it is needed for the next step
-
218  host_t<FieldMemRTheta<CoordRTheta>> feet_coords(grid);
-
219  ddc::for_each(grid, [&](IdxRTheta const irp) {
-
220  feet_coords(irp) = CoordRTheta(ddc::coordinate(irp));
-
221  });
-
222  m_find_feet(get_field(feet_coords), get_field(advection_field), dt);
+
210  // STEP 3: From rho^n and A^n, we compute rho^P: Vlasov equation
+
211  // --- Copy rho^n because it will be modified:
+
212  host_t<DFieldMemRTheta> allfdistribu_predicted(grid);
+
213  ddc::parallel_deepcopy(get_field(allfdistribu_predicted), allfdistribu);
+
214  m_advection_solver(get_field(allfdistribu_predicted), get_field(advection_field), dt);
+
215 
+
216  // --- advect also the feet because it is needed for the next step
+
217  host_t<FieldMemRTheta<CoordRTheta>> feet_coords(grid);
+
218  ddc::for_each(grid, [&](IdxRTheta const irp) {
+
219  feet_coords(irp) = CoordRTheta(ddc::coordinate(irp));
+
220  });
+
221  m_find_feet(get_field(feet_coords), get_field(advection_field), dt);
+
222 
223 
-
224 
-
225  // STEP 4: From rho^P, we compute phi^P: Poisson equation
-
226  m_builder(get_field(allfdistribu_coef), get_const_field(allfdistribu));
-
227  PoissonLikeRHSFunction const
-
228  charge_density_coord_4(get_const_field(allfdistribu_coef), m_evaluator);
-
229  m_poisson_solver(charge_density_coord_4, electrostatic_potential_coef);
-
230 
-
231  // STEP 5: From phi^P, we compute A^P:
-
232  advection_field_computer(electrostatic_potential_coef, advection_field_predicted);
+
224  // STEP 4: From rho^P, we compute phi^P: Poisson equation
+
225  m_builder(get_field(allfdistribu_coef), get_const_field(allfdistribu_predicted));
+
226  PoissonLikeRHSFunction const
+
227  charge_density_coord_4(get_const_field(allfdistribu_coef), m_evaluator);
+
228  m_poisson_solver(charge_density_coord_4, electrostatic_potential_coef);
+
229 
+
230  // STEP 5: From phi^P, we compute A^P:
+
231  advection_field_computer(electrostatic_potential_coef, advection_field_predicted);
+
232 
233 
-
234 
-
235  // --- we evaluate the advection field A^n at the characteristic feet X^Theta
-
236  host_t<DVectorFieldMemRTheta<X, Y>> advection_field_evaluated(grid);
-
237  host_t<VectorSplineCoeffsMem2D<X, Y>> advection_field_coefs(
-
238  get_spline_idx_range(m_builder));
-
239 
-
240  m_builder(
-
241  ddcHelper::get<X>(advection_field_coefs),
-
242  ddcHelper::get<X>(get_const_field(advection_field)));
-
243  m_builder(
-
244  ddcHelper::get<Y>(advection_field_coefs),
-
245  ddcHelper::get<Y>(get_const_field(advection_field)));
-
246 
-
247  m_evaluator(
-
248  get_field(ddcHelper::get<X>(advection_field_evaluated)),
-
249  get_const_field(feet_coords),
-
250  ddcHelper::get<X>(get_const_field(advection_field_coefs)));
-
251  m_evaluator(
-
252  get_field(ddcHelper::get<Y>(advection_field_evaluated)),
-
253  get_const_field(feet_coords),
-
254  ddcHelper::get<Y>(get_const_field(advection_field_coefs)));
+
234  // --- we evaluate the advection field A^n at the characteristic feet X^P
+
235  host_t<DVectorFieldMemRTheta<X, Y>> advection_field_evaluated(grid);
+
236  host_t<VectorSplineCoeffsMem2D<X, Y>> advection_field_coefs(
+
237  get_spline_idx_range(m_builder));
+
238 
+
239  m_builder(
+
240  ddcHelper::get<X>(advection_field_coefs),
+
241  ddcHelper::get<X>(get_const_field(advection_field)));
+
242  m_builder(
+
243  ddcHelper::get<Y>(advection_field_coefs),
+
244  ddcHelper::get<Y>(get_const_field(advection_field)));
+
245 
+
246  m_evaluator(
+
247  get_field(ddcHelper::get<X>(advection_field_evaluated)),
+
248  get_const_field(feet_coords),
+
249  ddcHelper::get<X>(get_const_field(advection_field_coefs)));
+
250  m_evaluator(
+
251  get_field(ddcHelper::get<Y>(advection_field_evaluated)),
+
252  get_const_field(feet_coords),
+
253  ddcHelper::get<Y>(get_const_field(advection_field_coefs)));
+
254 
255 
-
256 
-
257  // STEP 6: From rho^n and (A^n(X^P) + A^P(X^n))/2, we compute rho^{n+1}: Vlasov equation
-
258  ddc::for_each(grid, [&](IdxRTheta const irp) {
-
259  ddcHelper::get<X>(advection_field)(irp)
-
260  = (ddcHelper::get<X>(advection_field_evaluated)(irp)
-
261  + ddcHelper::get<X>(advection_field_predicted)(irp))
-
262  / 2.;
-
263  ddcHelper::get<Y>(advection_field)(irp)
-
264  = (ddcHelper::get<Y>(advection_field_evaluated)(irp)
-
265  + ddcHelper::get<Y>(advection_field_predicted)(irp))
-
266  / 2.;
-
267  });
+
256  // STEP 6: From rho^n and (A^n(X^P) + A^P(X^n))/2, we compute rho^{n+1}: Vlasov equation
+
257  ddc::for_each(grid, [&](IdxRTheta const irp) {
+
258  ddcHelper::get<X>(advection_field)(irp)
+
259  = (ddcHelper::get<X>(advection_field_evaluated)(irp)
+
260  + ddcHelper::get<X>(advection_field_predicted)(irp))
+
261  / 2.;
+
262  ddcHelper::get<Y>(advection_field)(irp)
+
263  = (ddcHelper::get<Y>(advection_field_evaluated)(irp)
+
264  + ddcHelper::get<Y>(advection_field_predicted)(irp))
+
265  / 2.;
+
266  });
+
267 
268 
-
269 
-
270  m_advection_solver(allfdistribu, get_field(advection_field), dt);
-
271  }
-
272 
-
273  // STEP 1: From rho^n, we compute phi^n: Poisson equation
-
274  host_t<Spline2DMem> allfdistribu_coef(get_spline_idx_range(m_builder));
-
275  m_builder(get_field(allfdistribu_coef), get_const_field(allfdistribu));
-
276  PoissonLikeRHSFunction const
-
277  charge_density_coord(get_const_field(allfdistribu_coef), m_evaluator);
-
278  m_poisson_solver(charge_density_coord, coords, electrical_potential);
-
279 
-
280  ddc::PdiEvent("last_iteration")
-
281  .with("iter", steps)
-
282  .and_with("time", steps * dt)
-
283  .and_with("density", allfdistribu)
-
284  .and_with("electrical_potential", electrical_potential);
+
269  m_advection_solver(allfdistribu, get_field(advection_field), dt);
+
270  }
+
271 
+
272  // STEP 1: From rho^n, we compute phi^n: Poisson equation
+
273  host_t<Spline2DMem> allfdistribu_coef(get_spline_idx_range(m_builder));
+
274  m_builder(get_field(allfdistribu_coef), get_const_field(allfdistribu));
+
275  PoissonLikeRHSFunction const
+
276  charge_density_coord(get_const_field(allfdistribu_coef), m_evaluator);
+
277  m_poisson_solver(charge_density_coord, coords, electrical_potential);
+
278 
+
279  ddc::PdiEvent("last_iteration")
+
280  .with("iter", steps)
+
281  .and_with("time", steps * dt)
+
282  .and_with("density", allfdistribu)
+
283  .and_with("electrical_potential", electrical_potential);
+
284 
285 
-
286 
-
287  end_time = std::chrono::system_clock::now();
-
288  display_time_difference("Iterations time: ", start_time, end_time);
+
286  end_time = std::chrono::system_clock::now();
+
287  display_time_difference("Iterations time: ", start_time, end_time);
+
288 
289 
-
290 
-
291  return allfdistribu;
-
292  }
-
293 };
+
290  return allfdistribu;
+
291  }
+
292 };
AdvectionDomain
Define a domain for the advection.
Definition: advection_domain.hpp:40
AdvectionFieldFinder
Solve the Poisson-like equation and return the electric field for the coupled Vlasov equation.
Definition: advection_field_rp.hpp:91
BslAdvectionRTheta
Define an advection operator on 2D index range.
Definition: bsl_advection_rp.hpp:60
BslExplicitPredCorrRTheta
A second order explicit predictor-corrector for the Vlasov-Poisson equations.
Definition: bsl_predcorr_second_order_explicit.hpp:66
-
BslExplicitPredCorrRTheta::operator()
host_t< DFieldRTheta > operator()(host_t< DFieldRTheta > allfdistribu, double const dt, int const steps) const
Solves on the equations system.
Definition: bsl_predcorr_second_order_explicit.hpp:140
BslExplicitPredCorrRTheta::BslExplicitPredCorrRTheta
BslExplicitPredCorrRTheta(AdvectionDomain const &advection_domain, Mapping const &mapping, BslAdvectionRTheta< SplineFootFinder< EulerMethod, AdvectionDomain >, Mapping > &advection_solver, IdxRangeRTheta const &grid, SplineRThetaBuilder const &builder, SplineRThetaEvaluatorNullBound const &rhs_evaluator, PolarSplineFEMPoissonLikeSolver const &poisson_solver, SplineRThetaEvaluatorConstBound const &advection_evaluator)
Instantiate a BslExplicitPredCorrRTheta.
Definition: bsl_predcorr_second_order_explicit.hpp:114
+
BslExplicitPredCorrRTheta::operator()
host_t< DFieldRTheta > operator()(host_t< DFieldRTheta > allfdistribu, double const dt, int const steps) const final
Solves on the equations system.
Definition: bsl_predcorr_second_order_explicit.hpp:140
CircularToCartesian
A class for describing the circular 2D mapping.
Definition: circular_to_cartesian.hpp:44
Euler
A class which provides an implementation of an explicit Euler method.
Definition: euler.hpp:33
ITimeSolverRTheta
Base class for the time solvers.
Definition: itimesolver.hpp:11
diff --git a/classBslExplicitPredCorrRTheta-members.html b/classBslExplicitPredCorrRTheta-members.html index fb7c7ccb0..caacaa102 100644 --- a/classBslExplicitPredCorrRTheta-members.html +++ b/classBslExplicitPredCorrRTheta-members.html @@ -108,8 +108,8 @@ - - + +
BslExplicitPredCorrRTheta(AdvectionDomain const &advection_domain, Mapping const &mapping, BslAdvectionRTheta< SplineFootFinder< EulerMethod, AdvectionDomain >, Mapping > &advection_solver, IdxRangeRTheta const &grid, SplineRThetaBuilder const &builder, SplineRThetaEvaluatorNullBound const &rhs_evaluator, PolarSplineFEMPoissonLikeSolver const &poisson_solver, SplineRThetaEvaluatorConstBound const &advection_evaluator)BslExplicitPredCorrRTheta< Mapping, AdvectionDomain >inline
display_time_difference(std::string const &title, std::chrono::time_point< std::chrono::system_clock > const &start_time, std::chrono::time_point< std::chrono::system_clock > const &end_time) constITimeSolverRThetainlineprotected
operator()(host_t< DFieldRTheta > allfdistribu, double const dt, int const steps) constBslExplicitPredCorrRTheta< Mapping, AdvectionDomain >inlinevirtual
~BslExplicitPredCorrRTheta() (defined in BslExplicitPredCorrRTheta< Mapping, AdvectionDomain >)BslExplicitPredCorrRTheta< Mapping, AdvectionDomain >inline
operator()(host_t< DFieldRTheta > allfdistribu, double const dt, int const steps) const finalBslExplicitPredCorrRTheta< Mapping, AdvectionDomain >inlinevirtual
~BslExplicitPredCorrRTheta() override (defined in BslExplicitPredCorrRTheta< Mapping, AdvectionDomain >)BslExplicitPredCorrRTheta< Mapping, AdvectionDomain >inline
~ITimeSolverRTheta()=default (defined in ITimeSolverRTheta)ITimeSolverRThetavirtual
diff --git a/classBslExplicitPredCorrRTheta.html b/classBslExplicitPredCorrRTheta.html index 63f1c1f26..364116a6a 100644 --- a/classBslExplicitPredCorrRTheta.html +++ b/classBslExplicitPredCorrRTheta.html @@ -124,9 +124,9 @@  BslExplicitPredCorrRTheta (AdvectionDomain const &advection_domain, Mapping const &mapping, BslAdvectionRTheta< SplineFootFinder< EulerMethod, AdvectionDomain >, Mapping > &advection_solver, IdxRangeRTheta const &grid, SplineRThetaBuilder const &builder, SplineRThetaEvaluatorNullBound const &rhs_evaluator, PolarSplineFEMPoissonLikeSolver const &poisson_solver, SplineRThetaEvaluatorConstBound const &advection_evaluator)  Instantiate a BslExplicitPredCorrRTheta. More...
  -host_t< DFieldRTheta > operator() (host_t< DFieldRTheta > allfdistribu, double const dt, int const steps) const - Solves on \( T = dt*N \) the equations system. More...
-  +host_t< DFieldRTheta > operator() (host_t< DFieldRTheta > allfdistribu, double const dt, int const steps) const final + Solves on \( T = dt*N \) the equations system. More...
+  @@ -260,8 +260,8 @@

Member Function Documentation

- -

◆ operator()()

+ +

◆ operator()()

@@ -297,7 +297,7 @@

-inlinevirtual +inlinefinalvirtual

Additional Inherited Members

diff --git a/classBslExplicitPredCorrRTheta.js b/classBslExplicitPredCorrRTheta.js index 92b5b0cd4..b864e972d 100644 --- a/classBslExplicitPredCorrRTheta.js +++ b/classBslExplicitPredCorrRTheta.js @@ -1,6 +1,6 @@ var classBslExplicitPredCorrRTheta = [ [ "BslExplicitPredCorrRTheta", "classBslExplicitPredCorrRTheta.html#a798b7348c59ee58fb5bdc09d2792b6cc", null ], - [ "~BslExplicitPredCorrRTheta", "classBslExplicitPredCorrRTheta.html#ab5b5e97a788d1556035afad5cdffb4db", null ], - [ "operator()", "classBslExplicitPredCorrRTheta.html#a4a0d13a36c04660e9416fd8dba361e43", null ] + [ "~BslExplicitPredCorrRTheta", "classBslExplicitPredCorrRTheta.html#a26b8afb30dc2978dab211c9b8cab1508", null ], + [ "operator()", "classBslExplicitPredCorrRTheta.html#aaf7de730188384e04d3121a0aab47d95", null ] ]; \ No newline at end of file diff --git a/classITimeSolverRTheta.html b/classITimeSolverRTheta.html index 86d4980df..6f4157f70 100644 --- a/classITimeSolverRTheta.html +++ b/classITimeSolverRTheta.html @@ -188,7 +188,7 @@

Returns
A Field toward allfdistribu.
-

Implemented in BslImplicitPredCorrRTheta< Mapping, AdvectionDomain >, BslExplicitPredCorrRTheta< Mapping, AdvectionDomain >, and BslPredCorrRTheta< Mapping, FootFinder >.

+

Implemented in BslExplicitPredCorrRTheta< Mapping, AdvectionDomain >, BslImplicitPredCorrRTheta< Mapping, AdvectionDomain >, and BslPredCorrRTheta< Mapping, FootFinder >.

diff --git a/navtreeindex0.js b/navtreeindex0.js index e598cb137..63b473147 100644 --- a/navtreeindex0.js +++ b/navtreeindex0.js @@ -129,9 +129,9 @@ var NAVTREEINDEX0 = "classBslAdvectionVelocity.html#a85c69c265dbb2410fdd60f7b78117593":[16,26,0], "classBslAdvectionVelocity.html#ad1278ae4fb0647b24ca667c123bb3e36":[16,26,2], "classBslExplicitPredCorrRTheta.html":[16,27], -"classBslExplicitPredCorrRTheta.html#a4a0d13a36c04660e9416fd8dba361e43":[16,27,2], +"classBslExplicitPredCorrRTheta.html#a26b8afb30dc2978dab211c9b8cab1508":[16,27,1], "classBslExplicitPredCorrRTheta.html#a798b7348c59ee58fb5bdc09d2792b6cc":[16,27,0], -"classBslExplicitPredCorrRTheta.html#ab5b5e97a788d1556035afad5cdffb4db":[16,27,1], +"classBslExplicitPredCorrRTheta.html#aaf7de730188384e04d3121a0aab47d95":[16,27,2], "classBslImplicitPredCorrRTheta.html":[16,28], "classBslImplicitPredCorrRTheta.html#a4dfd555928be9aaae3c0dd3529cb8be5":[16,28,0], "classBslImplicitPredCorrRTheta.html#a50ff84270975342a39ce7d967017e753":[16,28,1], diff --git a/search/all_e.js b/search/all_e.js index cfaf5531a..4ce4ca4e3 100644 --- a/search/all_e.js +++ b/search/all_e.js @@ -3,7 +3,7 @@ var searchData= ['onionpatchlocator_647',['OnionPatchLocator',['../classOnionPatchLocator_3_01MultipatchType_3_01IdxRangeOnPatch_00_01Patches_8_8_8_01_4_00_01Mapping_00_01ExecSpace_01_4.html#a243164d83738d38e20df707cd6169cee',1,'OnionPatchLocator< MultipatchType< IdxRangeOnPatch, Patches... >, Mapping, ExecSpace >::OnionPatchLocator()'],['../classOnionPatchLocator.html',1,'OnionPatchLocator< MultipatchIdxRanges, Mapping, ExecSpace >']]], ['onionpatchlocator_3c_20multipatchtype_3c_20idxrangeonpatch_2c_20patches_2e_2e_2e_20_3e_2c_20mapping_2c_20execspace_20_3e_648',['OnionPatchLocator< MultipatchType< IdxRangeOnPatch, Patches... >, Mapping, ExecSpace >',['../classOnionPatchLocator_3_01MultipatchType_3_01IdxRangeOnPatch_00_01Patches_8_8_8_01_4_00_01Mapping_00_01ExecSpace_01_4.html',1,'']]], ['operator_21_3d_649',['operator!=',['../structIdxRangeSliceIterator.html#af5bc866513c146093b042f3780c0be4e',1,'IdxRangeSliceIterator']]], - ['operator_28_29_650',['operator()',['../classIVlasovSolver.html#ae2c2b1a0762d06fe0beba20613003bff',1,'IVlasovSolver::operator()()'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a852a2a09220eabd3122cec7c741cacb2',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classSplitVlasovSolver.html#ad980db982084e40e1777484ddc3312b0',1,'SplitVlasovSolver::operator()()'],['../classLagrangeInterpolator.html#ac43d96b4a41419a6a1ff79a68c542be8',1,'LagrangeInterpolator::operator()()'],['../classIPreallocatableInterpolator.html#a007978d119b0e00f003d12691bb1cf23',1,'IPreallocatableInterpolator::operator()()'],['../classSplineInterpolator.html#a9b9364a501a3bb3ea480b0d5617cd614',1,'SplineInterpolator::operator()()'],['../classMPITransposeAllToAll.html#a15010bf5fb9a21443c9812482eb18f77',1,'MPITransposeAllToAll::operator()()'],['../classEdgeTransformation.html#ade4e3d76c60e46f6d36a8f6fc9fd8f49',1,'EdgeTransformation::operator()(Coord< CurrentDim > const &current_coord) const'],['../classEdgeTransformation.html#a953cea3a043308fbce6a55438daf7376',1,'EdgeTransformation::operator()(CurrentIdx const &current_idx) const'],['../classOnionPatchLocator_3_01MultipatchType_3_01IdxRangeOnPatch_00_01Patches_8_8_8_01_4_00_01Mapping_00_01ExecSpace_01_4.html#ae26cedcd2f3684cba126c4d400065724',1,'OnionPatchLocator< MultipatchType< IdxRangeOnPatch, Patches... >, Mapping, ExecSpace >::operator()()'],['../structConstantExtrapolationRuleOnion.html#a7949720967a9f6332b6cdf3edc16d6d8',1,'ConstantExtrapolationRuleOnion::operator()()'],['../classMultipatchSplineBuilder.html#a0e9a0659e97da24ba0e5f71939ace8f6',1,'MultipatchSplineBuilder::operator()()'],['../classMultipatchSplineBuilder2D.html#aa348d62045660886c7d1d5b6798f475c',1,'MultipatchSplineBuilder2D::operator()()'],['../classMultipatchSplineEvaluator2D.html#a6d3f057e123cd847109fae5a4e190149',1,'MultipatchSplineEvaluator2D::operator()(Coord const coord_eval, MultipatchSplineCoeff const &patches_splines) const'],['../classMultipatchSplineEvaluator2D.html#aaecde8a4cb5fccb1f10dadf7a09b4300',1,'MultipatchSplineEvaluator2D::operator()(MultipatchValues const &patches_values, MultipatchCoordField const &patches_coords, MultipatchSplineCoeff const &patches_splines) const'],['../structNullExtrapolationRule.html#afff2dfac58dbcfcc760da499bb23b953',1,'NullExtrapolationRule::operator()()'],['../classFEM1DPoissonSolver.html#a74360fade3d3986423b148334d88ea74',1,'FEM1DPoissonSolver::operator()(field_type phi, field_type rho) const override'],['../classFEM1DPoissonSolver.html#a066aa2568bdfd946f04c1d831debd663',1,'FEM1DPoissonSolver::operator()(field_type phi, vector_field_type E, field_type rho) const override'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a4bb7415769d706c9b48d3a66efd76c71',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classPredCorrHybrid.html#a6bfe0fdcbcc66b657bb0598cd4a1135c',1,'PredCorrHybrid::operator()()'],['../classIEquilibrium.html#ac3766d5ef01c1e949ec3dd6d55892a75',1,'IEquilibrium::operator()()'],['../classIInterpolator.html#aaa5c3e3e3114ea37952ebe02f7464a00',1,'IInterpolator::operator()()'],['../classFluidMoments.html#aeb2a3f97d8a00b2c5eed9df9e1317fd7',1,'FluidMoments::operator()(double &density, DConstFieldVx fdistribu, MomentDensity moment_density)'],['../classFluidMoments.html#a2ae74d24f0db28d93e39b88d885b90cd',1,'FluidMoments::operator()(DFieldSpX density, DConstFieldSpXVx allfdistribu, MomentDensity moment_density)'],['../classFluidMoments.html#a4ab19d391047e94ce2dcc8e73bf94faa',1,'FluidMoments::operator()(double &mean_velocity, DConstFieldVx fdistribu, double density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a60e881623a1a0db3245c690b4d7cc27f',1,'FluidMoments::operator()(DFieldSpX mean_velocity, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a180dd355d3d536623a0393c243af58d3',1,'FluidMoments::operator()(double &temperature, DConstFieldVx fdistribu, double density, double mean_velocity, MomentTemperature moment_temperature)'],['../classFluidMoments.html#ac15b6dd021fe761a18301a5475035aae',1,'FluidMoments::operator()(DFieldSpX temperature, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, DConstFieldSpX mean_velocity, MomentTemperature moment_temperature)'],['../classKelvinHelmholtzInstabilityInitialization.html#a7e681122586f70b241acc2c647cf2f67',1,'KelvinHelmholtzInstabilityInitialization::operator()()'],['../classPredCorrRK2XY.html#a03ce8460021646ecb76554cbb4f1b088',1,'PredCorrRK2XY::operator()()'],['../classPredCorr.html#afbad5baf6bfcce5c48b0cd47ce1de29d',1,'PredCorr::operator()()'],['../classIInitialization.html#a6fd840a3367ef39aed60a036fc196618',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#a883dfc9d838b53deeb47e93f178c7655',1,'MaxwellianEquilibrium::operator()()'],['../classSingleModePerturbInitialization.html#abcef02302c35de979ca2d34d5f4b5b8f',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a7ad6d91143f3e31e3ed8318a9970ef8e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a14a845fbe0e835ff765a33611f09bd8b',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a4df01b6445f6c8dc356ebce808102115',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#af216cca80bf1989bb5031c640b6e3db1',1,'NullQNSolver::operator()()'],['../classQNSolver.html#a7a295c1742a016b2f154a35a315a608c',1,'QNSolver::operator()()'],['../classITimeSolver.html#a66cc73d3765db94df87fc17cc215c01b',1,'ITimeSolver::operator()()'],['../classMetricTensor.html#afa4a1d1ac34eb5fc3a2464d3844151fe',1,'MetricTensor::operator()()'],['../classCartesianToBarycentricCoordinates.html#a5ca03e3d3d4f19dbc155224de01628b0',1,'CartesianToBarycentricCoordinates::operator()()'],['../classCircularToCartesian.html#a849aafcfea9f2c4c2e89ca2f75146fc1',1,'CircularToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCircularToCartesian.html#ab5e802ee75b64d7312855e6a3bc5e23e',1,'CircularToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classCoordinateConverter.html#a4e7ef7ef5ff4be5859b156ea9275b083',1,'CoordinateConverter::operator()()'],['../classCzarnyToCartesian.html#ad28940b525c4b28f87adfee86285dce7',1,'CzarnyToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCzarnyToCartesian.html#a1de36110060cd5b600e737390eb99150',1,'CzarnyToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classDiscreteToCartesianBuilder.html#ab1184f5129d2eb56b886bbd87bc6c455',1,'DiscreteToCartesianBuilder::operator()()'],['../classRefinedDiscreteToCartesianBuilder.html#a9f3e0871397a545472332eab2bc71e89',1,'RefinedDiscreteToCartesianBuilder::operator()()'],['../classDiscreteToCartesian.html#ad065663545d04ef95605491b2a623f71',1,'DiscreteToCartesian::operator()()'],['../classCartesianToBarycentricCoordinates.html#ae50d67d32dd5d0ba69ca7d0972d34fda',1,'CartesianToBarycentricCoordinates::operator()()'],['../classPolarSplineEvaluator.html#a648c0a6d88caf58e87f2f0c3101a7102',1,'PolarSplineEvaluator::operator()(ddc::Coordinate< DimR, DimTheta > coord_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classPolarSplineEvaluator.html#ad457a95e0b533ac37f258898c707ad7c',1,'PolarSplineEvaluator::operator()(ddc::ChunkSpan< double, Domain > const spline_eval, ddc::ChunkSpan< ddc::Coordinate< DimR, DimTheta > const, Domain > const coords_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classCosineEvaluator_1_1Evaluator.html#aa66ae25f58a330dd6669a09d0e6dee6c',1,'CosineEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classCosineEvaluator_1_1Evaluator.html#a9646ec811ec36ef5ea200ac2a1fc20ed',1,'CosineEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classEvaluator2D_1_1Evaluator.html#a2f34faff2f95045b3d0d0bda617b7ff4',1,'Evaluator2D::Evaluator::operator()(double const x, double const y) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a52c53285c56d8a940f5edd13c05eb040',1,'Evaluator2D::Evaluator::operator()(ddc::Coordinate< Grid1, Grid2 > const x) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a4e55b2215bc57bea73fa93988f9d7784',1,'Evaluator2D::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1, Grid2 >> chunk) const'],['../classPolynomialEvaluator_1_1Evaluator.html#a6d682cf47c575b13250525acff8a1d97',1,'PolynomialEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classPolynomialEvaluator_1_1Evaluator.html#a7e0f1582d25f41381bc18b9c0fcb74f4',1,'PolynomialEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classAdvectionField__translation.html#afd102ec3e9ce04fa1d0a38643525eb8d',1,'AdvectionField_translation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a1d7f488b18c1e625a847115976c1cef8',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classQuadrature.html#acc3a757e91e2d185ee290c409156fd4f',1,'Quadrature::operator()(ExecutionSpace exec_space, IntegratorFunction integrated_function) const'],['../classQuadrature.html#a5a7011a414f2f78524042fd2104342f0',1,'Quadrature::operator()(ExecutionSpace exec_space, Field< double, BatchIdxRange, std::experimental::layout_right, MemorySpace > const result, IntegratorFunction integrated_function) const'],['../classGridBuilder.html#a9b022df3951111963099676b1a580dc5',1,'GridBuilder::operator()()'],['../classFunctionToBeAdvected.html#ac469846a7162037505e058f7d248dc4b',1,'FunctionToBeAdvected::operator()()'],['../classFunctionToBeAdvected__cos__4__elipse.html#a2f35b8a7024c4e1e1d0a09e761abf56e',1,'FunctionToBeAdvected_cos_4_elipse::operator()()'],['../classFunctionToBeAdvected__gaussian.html#a5cefc067d3394e546900673571f6e612',1,'FunctionToBeAdvected_gaussian::operator()()'],['../classAdvectionField.html#ad83cd6e152724ab1c8e91be077eb5727',1,'AdvectionField::operator()()'],['../classAdvectionField__decentred__rotation.html#aaabb7b2f3ae0f6aadaa1b5e3a7d1a94f',1,'AdvectionField_decentred_rotation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a75d1a09001829464626a080c1ffa2f68',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classAdvectionField__rotation.html#a4dc539810d2d10aa68104841574802cf',1,'AdvectionField_rotation::operator()()'],['../classElectrostaticalPotentialSimulation.html#a445037f02ef92015762871398e8fd471',1,'ElectrostaticalPotentialSimulation::operator()()'],['../classElectrostaticalPotentialSimulation__decentred__rotation.html#a0a5322b2df29b69ab4c5438b5b0207af',1,'ElectrostaticalPotentialSimulation_decentred_rotation::operator()()'],['../classElectrostaticalPotentialSimulation__translation.html#ab42dce0f7ac411db86c2dd9871537189',1,'ElectrostaticalPotentialSimulation_translation::operator()()'],['../classElectrostaticalPotentialSimulation__rotation.html#af3f3c3819cbc815aa2a272028ef24fcd',1,'ElectrostaticalPotentialSimulation_rotation::operator()()'],['../classPoissonSolution.html#a88e27ab5b89c3992369e44ca7ecb56de',1,'PoissonSolution::operator()()'],['../classCurvilinearSolution.html#a88ec8a5cb7ec05b1abb9e9347016ea42',1,'CurvilinearSolution::operator()()'],['../classCartesianSolution.html#a0153345ef0de946e25e0bad9a68cc8dd',1,'CartesianSolution::operator()()'],['../classManufacturedPoissonTest.html#a88bc41fa060076c0477a808ac4395b79',1,'ManufacturedPoissonTest::operator()()'],['../classIQNSolver.html#ae11bcffd844aeadf69c5ff2e1e0305b6',1,'IQNSolver::operator()()'],['../classAdvectionFieldFinder.html#a16ae332726478b50a6234b22b9ab977e',1,'AdvectionFieldFinder::operator()(host_t< DFieldRTheta > electrostatic_potential, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a25dbc5a3703a7c81ca3f48b2ba8cb504',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a0411b8564a15c52c7374a419c33c7962',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a627c1dcadd341f200e312384b8ca3a52',1,'AdvectionFieldFinder::operator()(host_t< DFieldRTheta > electrostatic_potential, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#a127493f100ee2ebced546e80b3791662',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#aa272e8834000ff10dc7ce35d6d66de15',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classIInterpolatorRTheta.html#aced5e14f8fab92a58c72a12e563850ff',1,'IInterpolatorRTheta::operator()()'],['../classIPreallocatableInterpolatorRTheta.html#a46845d7c3ff21e134629490f4e879f3a',1,'IPreallocatableInterpolatorRTheta::operator()()'],['../classSplineInterpolatorRTheta.html#a49e46f474710a43e2c8d0d49491f16f4',1,'SplineInterpolatorRTheta::operator()()'],['../classSplineFootFinder.html#a0419e33b71f3551fc03d84ac9f669141',1,'SplineFootFinder::operator()()'],['../classPoissonLikeRHSFunction.html#a87f656365ccc4fe8d8fb650c0264679a',1,'PoissonLikeRHSFunction::operator()()'],['../classPolarSplineFEMPoissonLikeSolver.html#a208c1aab7d91aedcbe30231a46979c49',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, SplinePolar &spline) const'],['../classPolarSplineFEMPoissonLikeSolver.html#aa674e69e7db91ebbe8c0862fda157232',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, host_t< ConstFieldRTheta< CoordRTheta >> const coords_eval, host_t< DFieldRTheta > result) const'],['../classBslPredCorrRTheta.html#afcf39ab7a2574a1f4bb644d74347a84b',1,'BslPredCorrRTheta::operator()()'],['../classBslExplicitPredCorrRTheta.html#a4a0d13a36c04660e9416fd8dba361e43',1,'BslExplicitPredCorrRTheta::operator()()'],['../classBslImplicitPredCorrRTheta.html#ac3d7835dd0c995e3a9ecaa49474fc657',1,'BslImplicitPredCorrRTheta::operator()()'],['../classITimeSolverRTheta.html#a6b757c78184c80859037e523cac13e31',1,'ITimeSolverRTheta::operator()()'],['../classIEquilibrium.html#a58d9872d82ccadfbb3f215528463e30d',1,'IEquilibrium::operator()()'],['../classIInitialization.html#a6588f6592eaceff813dd509afce2d052',1,'IInitialization::operator()()'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#a14eaae81de1dcc49042634831a47ec9f',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()()'],['../classBslAdvection1D.html#ab6c09fdec0ac2ec060d846a03a775766',1,'BslAdvection1D::operator()()'],['../classBslAdvectionVelocity.html#ad1278ae4fb0647b24ca667c123bb3e36',1,'BslAdvectionVelocity::operator()()'],['../classBslAdvectionSpatial.html#a7179641516b4b75751638b5b905493e8',1,'BslAdvectionSpatial::operator()()'],['../classIAdvectionVelocity.html#af3daea164fd82a838975ff5dddf43676',1,'IAdvectionVelocity::operator()()'],['../classIAdvectionSpatial.html#a32a848ebf7598f793c50f515c9190452',1,'IAdvectionSpatial::operator()()'],['../classNullAdvectionVelocity.html#ad75024862512241516864edf382b14c0',1,'NullAdvectionVelocity::operator()()'],['../classCollisionSpVparMu.html#a87ae0a4bf2125a89b0f5235d6217b545',1,'CollisionSpVparMu::operator()()'],['../classDerivField_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01LayoutStridedPolicy_00_01MemorySpace_01_4.html#a378ab989db882557227b0e71eed8c4d8',1,'DerivField< ElementType, IdxRange< DDims... >, LayoutStridedPolicy, MemorySpace >::operator()()'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#ad75d8f24cde91009e1e0e80f0ceae224',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()()'],['../classPredCorr.html#a2a3c70566fbfaef1d04bb540c980e7d1',1,'PredCorr::operator()()'],['../classVectorField.html#a97f23f71edd98dd8adb12184b1ccead6',1,'VectorField::operator()(Idx< ODDims > const &... delems) const noexcept'],['../classVectorField.html#a8dc232b7be4d650ac49cf52208aaca6c',1,'VectorField::operator()(Idx< ODDims... > const &delems) const noexcept'],['../classVectorFieldMem.html#a0b2e8ceb5595ef98d07d42d12b41601d',1,'VectorFieldMem::operator()(Idx< ODDims > const &... delems) const noexcept'],['../classVectorFieldMem.html#ab9430bd40d0b0924dc2a5735617483a5',1,'VectorFieldMem::operator()(Idx< ODDims... > const &delems) const noexcept'],['../classBslAdvectionRTheta.html#a4304e54db2d9ca10f3c57b358299427e',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field_xy, double dt) const'],['../classBslAdvectionRTheta.html#a2a0284e6fcae81c7f98cceade91494a8',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY const &advection_field_xy_center, double dt) const'],['../classIAdvectionRTheta.html#a4f626c6b5ce9b190f5b80d09384938f5',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field, double const dt) const =0'],['../classIAdvectionRTheta.html#a1dc3db8c2963ef6baf81ea1b3432bb10',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field, CoordXY const &advection_field_xy_center, double const dt) const =0'],['../classIFootFinder.html#a4b4e64d793fc6cd63e5771f3ebf89308',1,'IFootFinder::operator()()'],['../classQNSolver.html#a866ea0a8cd34e7789d8847aaf963fdf2',1,'QNSolver::operator()()'],['../classIEquilibrium.html#a3ea3adf00a9a416a8e3fe54caba902a4',1,'IEquilibrium::operator()()'],['../classIInitialization.html#ac70366059a8d5679ff45c1a3eed5ad6b',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#af3b41f93de3bb96ae0b44d8f89ee2a0a',1,'MaxwellianEquilibrium::operator()()'],['../classRestartInitialization.html#adb0bfb34f2397f95e8d559e5b04222b8',1,'RestartInitialization::operator()()'],['../classSingleModePerturbInitialization.html#a6fe8be7de3eefd844b3f15e7d50b1707',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a164ef05aba41f41d7862c1aa216c154e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a33642031ef4d350e865b9b3d81f6bc76',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a0a2d3c31695c821a43582f1c2cd4e928',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#ac636ac6b797e8bf883a53955f191d4ed',1,'NullQNSolver::operator()()'],['../classIEquilibrium.html#a425f7b104d75900fcc769bdee9c0cdbd',1,'IEquilibrium::operator()()'],['../classCollisionsInter.html#a1f8104eb5930b71b25856a0640c534bf',1,'CollisionsInter::operator()()'],['../classCollisionsIntra.html#ad066a79f6c0a9dcf3720dbfc5e9056e0',1,'CollisionsIntra::operator()()'],['../classIRightHandSide.html#a00f66ff88f6b0fd17a931a09b1ddb2d3',1,'IRightHandSide::operator()()'],['../classKineticSource.html#a384f4c655ebe246d99964de77ee780d2',1,'KineticSource::operator()()'],['../classKrookSourceAdaptive.html#a1f7a6ce3a4f5f93214352a4787ba7888',1,'KrookSourceAdaptive::operator()()'],['../classKrookSourceConstant.html#a266237a1a58a6f8f000ee4e910353dcc',1,'KrookSourceConstant::operator()()'],['../classITimeSolver.html#abfdecd652433d1ae388a6489da2ed865',1,'ITimeSolver::operator()()'],['../classITimeSolverHybrid.html#aa65ff6d73a2a7a97aeed15dab0ab3d94',1,'ITimeSolverHybrid::operator()()'],['../classMaxwellianEquilibrium.html#a0a2a1b781c2e521696ffc22c02d52282',1,'MaxwellianEquilibrium::operator()()'],['../classRecombinationRate.html#afc0642ee5f185d34df820b67d3b360e9',1,'RecombinationRate::operator()()'],['../classIInitialization.html#abc23a07c3e1a7852b4be401e57526061',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#a0cc2b9bdb6300dd5661cedbfc27957b3',1,'MaxwellianEquilibrium::operator()()'],['../classNoPerturbInitialization.html#a7debfeb8001108b1fb6d431ecf98a19e',1,'NoPerturbInitialization::operator()()'],['../classIBoltzmannSolver.html#aedf19fb0ae7e0bf80729c9f761ee20ed',1,'IBoltzmannSolver::operator()()'],['../classSplitRightHandSideSolver.html#a350971eed31753861f6e2917b9b6b968',1,'SplitRightHandSideSolver::operator()()'],['../classSplitVlasovSolver.html#a958b142757ef330191c9c25188294f15',1,'SplitVlasovSolver::operator()()'],['../classConstantFluidInitialization.html#a1fbff918b2671a42ea378127f1223708',1,'ConstantFluidInitialization::operator()()'],['../classIFluidInitialization.html#ac61ad3c8aec9bc3b1bd40998dee90e2c',1,'IFluidInitialization::operator()()'],['../classDiffusiveNeutralSolver.html#af44bb1d70fd2a551ed4fc7008b564d5b',1,'DiffusiveNeutralSolver::operator()()'],['../classIFluidTransportSolver.html#a7b533a63875dcba416c647dfab0dd7eb',1,'IFluidTransportSolver::operator()()'],['../classNullFluidSolver.html#a57df0286d899f8278d9147aeea564292',1,'NullFluidSolver::operator()()'],['../classIKineticFluidCoupling.html#a915230ecc7ba3faffc9279f0283bb0b3',1,'IKineticFluidCoupling::operator()()'],['../classKineticFluidCouplingSource.html#a8d185066590f530d132ecfd4d4b315be',1,'KineticFluidCouplingSource::operator()()'],['../classChargeExchangeRate.html#a73b415cda84b9f40a85da1d4f5d377b4',1,'ChargeExchangeRate::operator()()'],['../classConstantRate.html#ada12e13f0c3e2b98cb5b2c35a21be9b9',1,'ConstantRate::operator()()'],['../classIonizationRate.html#a04169db7340af25ff0c760184148c81a',1,'IonizationRate::operator()()'],['../classIReactionRate.html#aa53dd629fec8987317cc634bb52d7fe3',1,'IReactionRate::operator()()'],['../classBumpontailEquilibrium.html#a4c85a379ea216bb7ac95186cf8af8817',1,'BumpontailEquilibrium::operator()()']]], + ['operator_28_29_650',['operator()',['../classIVlasovSolver.html#ae2c2b1a0762d06fe0beba20613003bff',1,'IVlasovSolver::operator()()'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a852a2a09220eabd3122cec7c741cacb2',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classSplitVlasovSolver.html#ad980db982084e40e1777484ddc3312b0',1,'SplitVlasovSolver::operator()()'],['../classLagrangeInterpolator.html#ac43d96b4a41419a6a1ff79a68c542be8',1,'LagrangeInterpolator::operator()()'],['../classIPreallocatableInterpolator.html#a007978d119b0e00f003d12691bb1cf23',1,'IPreallocatableInterpolator::operator()()'],['../classSplineInterpolator.html#a9b9364a501a3bb3ea480b0d5617cd614',1,'SplineInterpolator::operator()()'],['../classMPITransposeAllToAll.html#a15010bf5fb9a21443c9812482eb18f77',1,'MPITransposeAllToAll::operator()()'],['../classEdgeTransformation.html#ade4e3d76c60e46f6d36a8f6fc9fd8f49',1,'EdgeTransformation::operator()(Coord< CurrentDim > const &current_coord) const'],['../classEdgeTransformation.html#a953cea3a043308fbce6a55438daf7376',1,'EdgeTransformation::operator()(CurrentIdx const &current_idx) const'],['../classOnionPatchLocator_3_01MultipatchType_3_01IdxRangeOnPatch_00_01Patches_8_8_8_01_4_00_01Mapping_00_01ExecSpace_01_4.html#ae26cedcd2f3684cba126c4d400065724',1,'OnionPatchLocator< MultipatchType< IdxRangeOnPatch, Patches... >, Mapping, ExecSpace >::operator()()'],['../structConstantExtrapolationRuleOnion.html#a7949720967a9f6332b6cdf3edc16d6d8',1,'ConstantExtrapolationRuleOnion::operator()()'],['../classMultipatchSplineBuilder.html#a0e9a0659e97da24ba0e5f71939ace8f6',1,'MultipatchSplineBuilder::operator()()'],['../classMultipatchSplineBuilder2D.html#aa348d62045660886c7d1d5b6798f475c',1,'MultipatchSplineBuilder2D::operator()()'],['../classMultipatchSplineEvaluator2D.html#a6d3f057e123cd847109fae5a4e190149',1,'MultipatchSplineEvaluator2D::operator()(Coord const coord_eval, MultipatchSplineCoeff const &patches_splines) const'],['../classMultipatchSplineEvaluator2D.html#aaecde8a4cb5fccb1f10dadf7a09b4300',1,'MultipatchSplineEvaluator2D::operator()(MultipatchValues const &patches_values, MultipatchCoordField const &patches_coords, MultipatchSplineCoeff const &patches_splines) const'],['../structNullExtrapolationRule.html#afff2dfac58dbcfcc760da499bb23b953',1,'NullExtrapolationRule::operator()()'],['../classFEM1DPoissonSolver.html#a74360fade3d3986423b148334d88ea74',1,'FEM1DPoissonSolver::operator()(field_type phi, field_type rho) const override'],['../classFEM1DPoissonSolver.html#a066aa2568bdfd946f04c1d831debd663',1,'FEM1DPoissonSolver::operator()(field_type phi, vector_field_type E, field_type rho) const override'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a4bb7415769d706c9b48d3a66efd76c71',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classPredCorrHybrid.html#a6bfe0fdcbcc66b657bb0598cd4a1135c',1,'PredCorrHybrid::operator()()'],['../classIEquilibrium.html#ac3766d5ef01c1e949ec3dd6d55892a75',1,'IEquilibrium::operator()()'],['../classIInterpolator.html#aaa5c3e3e3114ea37952ebe02f7464a00',1,'IInterpolator::operator()()'],['../classFluidMoments.html#aeb2a3f97d8a00b2c5eed9df9e1317fd7',1,'FluidMoments::operator()(double &density, DConstFieldVx fdistribu, MomentDensity moment_density)'],['../classFluidMoments.html#a2ae74d24f0db28d93e39b88d885b90cd',1,'FluidMoments::operator()(DFieldSpX density, DConstFieldSpXVx allfdistribu, MomentDensity moment_density)'],['../classFluidMoments.html#a4ab19d391047e94ce2dcc8e73bf94faa',1,'FluidMoments::operator()(double &mean_velocity, DConstFieldVx fdistribu, double density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a60e881623a1a0db3245c690b4d7cc27f',1,'FluidMoments::operator()(DFieldSpX mean_velocity, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a180dd355d3d536623a0393c243af58d3',1,'FluidMoments::operator()(double &temperature, DConstFieldVx fdistribu, double density, double mean_velocity, MomentTemperature moment_temperature)'],['../classFluidMoments.html#ac15b6dd021fe761a18301a5475035aae',1,'FluidMoments::operator()(DFieldSpX temperature, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, DConstFieldSpX mean_velocity, MomentTemperature moment_temperature)'],['../classKelvinHelmholtzInstabilityInitialization.html#a7e681122586f70b241acc2c647cf2f67',1,'KelvinHelmholtzInstabilityInitialization::operator()()'],['../classPredCorrRK2XY.html#a03ce8460021646ecb76554cbb4f1b088',1,'PredCorrRK2XY::operator()()'],['../classPredCorr.html#afbad5baf6bfcce5c48b0cd47ce1de29d',1,'PredCorr::operator()()'],['../classIInitialization.html#a6fd840a3367ef39aed60a036fc196618',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#a883dfc9d838b53deeb47e93f178c7655',1,'MaxwellianEquilibrium::operator()()'],['../classSingleModePerturbInitialization.html#abcef02302c35de979ca2d34d5f4b5b8f',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a7ad6d91143f3e31e3ed8318a9970ef8e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a14a845fbe0e835ff765a33611f09bd8b',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a4df01b6445f6c8dc356ebce808102115',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#af216cca80bf1989bb5031c640b6e3db1',1,'NullQNSolver::operator()()'],['../classQNSolver.html#a7a295c1742a016b2f154a35a315a608c',1,'QNSolver::operator()()'],['../classITimeSolver.html#a66cc73d3765db94df87fc17cc215c01b',1,'ITimeSolver::operator()()'],['../classMetricTensor.html#afa4a1d1ac34eb5fc3a2464d3844151fe',1,'MetricTensor::operator()()'],['../classCartesianToBarycentricCoordinates.html#a5ca03e3d3d4f19dbc155224de01628b0',1,'CartesianToBarycentricCoordinates::operator()()'],['../classCircularToCartesian.html#a849aafcfea9f2c4c2e89ca2f75146fc1',1,'CircularToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCircularToCartesian.html#ab5e802ee75b64d7312855e6a3bc5e23e',1,'CircularToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classCoordinateConverter.html#a4e7ef7ef5ff4be5859b156ea9275b083',1,'CoordinateConverter::operator()()'],['../classCzarnyToCartesian.html#ad28940b525c4b28f87adfee86285dce7',1,'CzarnyToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCzarnyToCartesian.html#a1de36110060cd5b600e737390eb99150',1,'CzarnyToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classDiscreteToCartesianBuilder.html#ab1184f5129d2eb56b886bbd87bc6c455',1,'DiscreteToCartesianBuilder::operator()()'],['../classRefinedDiscreteToCartesianBuilder.html#a9f3e0871397a545472332eab2bc71e89',1,'RefinedDiscreteToCartesianBuilder::operator()()'],['../classDiscreteToCartesian.html#ad065663545d04ef95605491b2a623f71',1,'DiscreteToCartesian::operator()()'],['../classCartesianToBarycentricCoordinates.html#ae50d67d32dd5d0ba69ca7d0972d34fda',1,'CartesianToBarycentricCoordinates::operator()()'],['../classPolarSplineEvaluator.html#a648c0a6d88caf58e87f2f0c3101a7102',1,'PolarSplineEvaluator::operator()(ddc::Coordinate< DimR, DimTheta > coord_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classPolarSplineEvaluator.html#ad457a95e0b533ac37f258898c707ad7c',1,'PolarSplineEvaluator::operator()(ddc::ChunkSpan< double, Domain > const spline_eval, ddc::ChunkSpan< ddc::Coordinate< DimR, DimTheta > const, Domain > const coords_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classCosineEvaluator_1_1Evaluator.html#aa66ae25f58a330dd6669a09d0e6dee6c',1,'CosineEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classCosineEvaluator_1_1Evaluator.html#a9646ec811ec36ef5ea200ac2a1fc20ed',1,'CosineEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classEvaluator2D_1_1Evaluator.html#a2f34faff2f95045b3d0d0bda617b7ff4',1,'Evaluator2D::Evaluator::operator()(double const x, double const y) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a52c53285c56d8a940f5edd13c05eb040',1,'Evaluator2D::Evaluator::operator()(ddc::Coordinate< Grid1, Grid2 > const x) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a4e55b2215bc57bea73fa93988f9d7784',1,'Evaluator2D::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1, Grid2 >> chunk) const'],['../classPolynomialEvaluator_1_1Evaluator.html#a6d682cf47c575b13250525acff8a1d97',1,'PolynomialEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classPolynomialEvaluator_1_1Evaluator.html#a7e0f1582d25f41381bc18b9c0fcb74f4',1,'PolynomialEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classAdvectionField__translation.html#afd102ec3e9ce04fa1d0a38643525eb8d',1,'AdvectionField_translation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a1d7f488b18c1e625a847115976c1cef8',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classQuadrature.html#acc3a757e91e2d185ee290c409156fd4f',1,'Quadrature::operator()(ExecutionSpace exec_space, IntegratorFunction integrated_function) const'],['../classQuadrature.html#a5a7011a414f2f78524042fd2104342f0',1,'Quadrature::operator()(ExecutionSpace exec_space, Field< double, BatchIdxRange, std::experimental::layout_right, MemorySpace > const result, IntegratorFunction integrated_function) const'],['../classGridBuilder.html#a9b022df3951111963099676b1a580dc5',1,'GridBuilder::operator()()'],['../classFunctionToBeAdvected.html#ac469846a7162037505e058f7d248dc4b',1,'FunctionToBeAdvected::operator()()'],['../classFunctionToBeAdvected__cos__4__elipse.html#a2f35b8a7024c4e1e1d0a09e761abf56e',1,'FunctionToBeAdvected_cos_4_elipse::operator()()'],['../classFunctionToBeAdvected__gaussian.html#a5cefc067d3394e546900673571f6e612',1,'FunctionToBeAdvected_gaussian::operator()()'],['../classAdvectionField.html#ad83cd6e152724ab1c8e91be077eb5727',1,'AdvectionField::operator()()'],['../classAdvectionField__decentred__rotation.html#aaabb7b2f3ae0f6aadaa1b5e3a7d1a94f',1,'AdvectionField_decentred_rotation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a75d1a09001829464626a080c1ffa2f68',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classAdvectionField__rotation.html#a4dc539810d2d10aa68104841574802cf',1,'AdvectionField_rotation::operator()()'],['../classElectrostaticalPotentialSimulation.html#a445037f02ef92015762871398e8fd471',1,'ElectrostaticalPotentialSimulation::operator()()'],['../classElectrostaticalPotentialSimulation__decentred__rotation.html#a0a5322b2df29b69ab4c5438b5b0207af',1,'ElectrostaticalPotentialSimulation_decentred_rotation::operator()()'],['../classElectrostaticalPotentialSimulation__translation.html#ab42dce0f7ac411db86c2dd9871537189',1,'ElectrostaticalPotentialSimulation_translation::operator()()'],['../classElectrostaticalPotentialSimulation__rotation.html#af3f3c3819cbc815aa2a272028ef24fcd',1,'ElectrostaticalPotentialSimulation_rotation::operator()()'],['../classPoissonSolution.html#a88e27ab5b89c3992369e44ca7ecb56de',1,'PoissonSolution::operator()()'],['../classCurvilinearSolution.html#a88ec8a5cb7ec05b1abb9e9347016ea42',1,'CurvilinearSolution::operator()()'],['../classCartesianSolution.html#a0153345ef0de946e25e0bad9a68cc8dd',1,'CartesianSolution::operator()()'],['../classManufacturedPoissonTest.html#a88bc41fa060076c0477a808ac4395b79',1,'ManufacturedPoissonTest::operator()()'],['../classIQNSolver.html#ae11bcffd844aeadf69c5ff2e1e0305b6',1,'IQNSolver::operator()()'],['../classAdvectionFieldFinder.html#a16ae332726478b50a6234b22b9ab977e',1,'AdvectionFieldFinder::operator()(host_t< DFieldRTheta > electrostatic_potential, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a25dbc5a3703a7c81ca3f48b2ba8cb504',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a0411b8564a15c52c7374a419c33c7962',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a627c1dcadd341f200e312384b8ca3a52',1,'AdvectionFieldFinder::operator()(host_t< DFieldRTheta > electrostatic_potential, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#a127493f100ee2ebced546e80b3791662',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#aa272e8834000ff10dc7ce35d6d66de15',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classIInterpolatorRTheta.html#aced5e14f8fab92a58c72a12e563850ff',1,'IInterpolatorRTheta::operator()()'],['../classIPreallocatableInterpolatorRTheta.html#a46845d7c3ff21e134629490f4e879f3a',1,'IPreallocatableInterpolatorRTheta::operator()()'],['../classSplineInterpolatorRTheta.html#a49e46f474710a43e2c8d0d49491f16f4',1,'SplineInterpolatorRTheta::operator()()'],['../classSplineFootFinder.html#a0419e33b71f3551fc03d84ac9f669141',1,'SplineFootFinder::operator()()'],['../classPoissonLikeRHSFunction.html#a87f656365ccc4fe8d8fb650c0264679a',1,'PoissonLikeRHSFunction::operator()()'],['../classPolarSplineFEMPoissonLikeSolver.html#a208c1aab7d91aedcbe30231a46979c49',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, SplinePolar &spline) const'],['../classPolarSplineFEMPoissonLikeSolver.html#aa674e69e7db91ebbe8c0862fda157232',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, host_t< ConstFieldRTheta< CoordRTheta >> const coords_eval, host_t< DFieldRTheta > result) const'],['../classBslPredCorrRTheta.html#afcf39ab7a2574a1f4bb644d74347a84b',1,'BslPredCorrRTheta::operator()()'],['../classBslExplicitPredCorrRTheta.html#aaf7de730188384e04d3121a0aab47d95',1,'BslExplicitPredCorrRTheta::operator()()'],['../classBslImplicitPredCorrRTheta.html#ac3d7835dd0c995e3a9ecaa49474fc657',1,'BslImplicitPredCorrRTheta::operator()()'],['../classITimeSolverRTheta.html#a6b757c78184c80859037e523cac13e31',1,'ITimeSolverRTheta::operator()()'],['../classIEquilibrium.html#a58d9872d82ccadfbb3f215528463e30d',1,'IEquilibrium::operator()()'],['../classIInitialization.html#a6588f6592eaceff813dd509afce2d052',1,'IInitialization::operator()()'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#a14eaae81de1dcc49042634831a47ec9f',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()()'],['../classBslAdvection1D.html#ab6c09fdec0ac2ec060d846a03a775766',1,'BslAdvection1D::operator()()'],['../classBslAdvectionVelocity.html#ad1278ae4fb0647b24ca667c123bb3e36',1,'BslAdvectionVelocity::operator()()'],['../classBslAdvectionSpatial.html#a7179641516b4b75751638b5b905493e8',1,'BslAdvectionSpatial::operator()()'],['../classIAdvectionVelocity.html#af3daea164fd82a838975ff5dddf43676',1,'IAdvectionVelocity::operator()()'],['../classIAdvectionSpatial.html#a32a848ebf7598f793c50f515c9190452',1,'IAdvectionSpatial::operator()()'],['../classNullAdvectionVelocity.html#ad75024862512241516864edf382b14c0',1,'NullAdvectionVelocity::operator()()'],['../classCollisionSpVparMu.html#a87ae0a4bf2125a89b0f5235d6217b545',1,'CollisionSpVparMu::operator()()'],['../classDerivField_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01LayoutStridedPolicy_00_01MemorySpace_01_4.html#a378ab989db882557227b0e71eed8c4d8',1,'DerivField< ElementType, IdxRange< DDims... >, LayoutStridedPolicy, MemorySpace >::operator()()'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#ad75d8f24cde91009e1e0e80f0ceae224',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()()'],['../classPredCorr.html#a2a3c70566fbfaef1d04bb540c980e7d1',1,'PredCorr::operator()()'],['../classVectorField.html#a97f23f71edd98dd8adb12184b1ccead6',1,'VectorField::operator()(Idx< ODDims > const &... delems) const noexcept'],['../classVectorField.html#a8dc232b7be4d650ac49cf52208aaca6c',1,'VectorField::operator()(Idx< ODDims... > const &delems) const noexcept'],['../classVectorFieldMem.html#a0b2e8ceb5595ef98d07d42d12b41601d',1,'VectorFieldMem::operator()(Idx< ODDims > const &... delems) const noexcept'],['../classVectorFieldMem.html#ab9430bd40d0b0924dc2a5735617483a5',1,'VectorFieldMem::operator()(Idx< ODDims... > const &delems) const noexcept'],['../classBslAdvectionRTheta.html#a4304e54db2d9ca10f3c57b358299427e',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field_xy, double dt) const'],['../classBslAdvectionRTheta.html#a2a0284e6fcae81c7f98cceade91494a8',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY const &advection_field_xy_center, double dt) const'],['../classIAdvectionRTheta.html#a4f626c6b5ce9b190f5b80d09384938f5',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field, double const dt) const =0'],['../classIAdvectionRTheta.html#a1dc3db8c2963ef6baf81ea1b3432bb10',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field, CoordXY const &advection_field_xy_center, double const dt) const =0'],['../classIFootFinder.html#a4b4e64d793fc6cd63e5771f3ebf89308',1,'IFootFinder::operator()()'],['../classQNSolver.html#a866ea0a8cd34e7789d8847aaf963fdf2',1,'QNSolver::operator()()'],['../classIEquilibrium.html#a3ea3adf00a9a416a8e3fe54caba902a4',1,'IEquilibrium::operator()()'],['../classIInitialization.html#ac70366059a8d5679ff45c1a3eed5ad6b',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#af3b41f93de3bb96ae0b44d8f89ee2a0a',1,'MaxwellianEquilibrium::operator()()'],['../classRestartInitialization.html#adb0bfb34f2397f95e8d559e5b04222b8',1,'RestartInitialization::operator()()'],['../classSingleModePerturbInitialization.html#a6fe8be7de3eefd844b3f15e7d50b1707',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a164ef05aba41f41d7862c1aa216c154e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a33642031ef4d350e865b9b3d81f6bc76',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a0a2d3c31695c821a43582f1c2cd4e928',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#ac636ac6b797e8bf883a53955f191d4ed',1,'NullQNSolver::operator()()'],['../classIEquilibrium.html#a425f7b104d75900fcc769bdee9c0cdbd',1,'IEquilibrium::operator()()'],['../classCollisionsInter.html#a1f8104eb5930b71b25856a0640c534bf',1,'CollisionsInter::operator()()'],['../classCollisionsIntra.html#ad066a79f6c0a9dcf3720dbfc5e9056e0',1,'CollisionsIntra::operator()()'],['../classIRightHandSide.html#a00f66ff88f6b0fd17a931a09b1ddb2d3',1,'IRightHandSide::operator()()'],['../classKineticSource.html#a384f4c655ebe246d99964de77ee780d2',1,'KineticSource::operator()()'],['../classKrookSourceAdaptive.html#a1f7a6ce3a4f5f93214352a4787ba7888',1,'KrookSourceAdaptive::operator()()'],['../classKrookSourceConstant.html#a266237a1a58a6f8f000ee4e910353dcc',1,'KrookSourceConstant::operator()()'],['../classITimeSolver.html#abfdecd652433d1ae388a6489da2ed865',1,'ITimeSolver::operator()()'],['../classITimeSolverHybrid.html#aa65ff6d73a2a7a97aeed15dab0ab3d94',1,'ITimeSolverHybrid::operator()()'],['../classMaxwellianEquilibrium.html#a0a2a1b781c2e521696ffc22c02d52282',1,'MaxwellianEquilibrium::operator()()'],['../classRecombinationRate.html#afc0642ee5f185d34df820b67d3b360e9',1,'RecombinationRate::operator()()'],['../classIInitialization.html#abc23a07c3e1a7852b4be401e57526061',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#a0cc2b9bdb6300dd5661cedbfc27957b3',1,'MaxwellianEquilibrium::operator()()'],['../classNoPerturbInitialization.html#a7debfeb8001108b1fb6d431ecf98a19e',1,'NoPerturbInitialization::operator()()'],['../classIBoltzmannSolver.html#aedf19fb0ae7e0bf80729c9f761ee20ed',1,'IBoltzmannSolver::operator()()'],['../classSplitRightHandSideSolver.html#a350971eed31753861f6e2917b9b6b968',1,'SplitRightHandSideSolver::operator()()'],['../classSplitVlasovSolver.html#a958b142757ef330191c9c25188294f15',1,'SplitVlasovSolver::operator()()'],['../classConstantFluidInitialization.html#a1fbff918b2671a42ea378127f1223708',1,'ConstantFluidInitialization::operator()()'],['../classIFluidInitialization.html#ac61ad3c8aec9bc3b1bd40998dee90e2c',1,'IFluidInitialization::operator()()'],['../classDiffusiveNeutralSolver.html#af44bb1d70fd2a551ed4fc7008b564d5b',1,'DiffusiveNeutralSolver::operator()()'],['../classIFluidTransportSolver.html#a7b533a63875dcba416c647dfab0dd7eb',1,'IFluidTransportSolver::operator()()'],['../classNullFluidSolver.html#a57df0286d899f8278d9147aeea564292',1,'NullFluidSolver::operator()()'],['../classIKineticFluidCoupling.html#a915230ecc7ba3faffc9279f0283bb0b3',1,'IKineticFluidCoupling::operator()()'],['../classKineticFluidCouplingSource.html#a8d185066590f530d132ecfd4d4b315be',1,'KineticFluidCouplingSource::operator()()'],['../classChargeExchangeRate.html#a73b415cda84b9f40a85da1d4f5d377b4',1,'ChargeExchangeRate::operator()()'],['../classConstantRate.html#ada12e13f0c3e2b98cb5b2c35a21be9b9',1,'ConstantRate::operator()()'],['../classIonizationRate.html#a04169db7340af25ff0c760184148c81a',1,'IonizationRate::operator()()'],['../classIReactionRate.html#aa53dd629fec8987317cc634bb52d7fe3',1,'IReactionRate::operator()()'],['../classBumpontailEquilibrium.html#a4c85a379ea216bb7ac95186cf8af8817',1,'BumpontailEquilibrium::operator()()']]], ['operator_2a_651',['operator*',['../structIdxRangeSliceIterator.html#a2978026bd938a7badfc0429d98f69189',1,'IdxRangeSliceIterator']]], ['operator_2b_652',['operator+',['../structIdxRangeSliceIterator.html#a9539566c24effedeeaa603fcf15c4811',1,'IdxRangeSliceIterator::operator+()'],['../structIdxRangeSliceIterator.html#ae0ee5c8ecbc1cb7b6147f30ac2f3aab7',1,'IdxRangeSliceIterator::operator+()']]], ['operator_2b_2b_653',['operator++',['../structIdxRangeSliceIterator.html#aad83e0db3e4dae980fe233be4d9cd05a',1,'IdxRangeSliceIterator::operator++()'],['../structIdxRangeSliceIterator.html#ae6a30746321bcc04eaa331f8466383e7',1,'IdxRangeSliceIterator::operator++(int)']]], diff --git a/search/functions_e.js b/search/functions_e.js index b47158827..ed7a7caa6 100644 --- a/search/functions_e.js +++ b/search/functions_e.js @@ -1,7 +1,7 @@ var searchData= [ ['onionpatchlocator_1493',['OnionPatchLocator',['../classOnionPatchLocator_3_01MultipatchType_3_01IdxRangeOnPatch_00_01Patches_8_8_8_01_4_00_01Mapping_00_01ExecSpace_01_4.html#a243164d83738d38e20df707cd6169cee',1,'OnionPatchLocator< MultipatchType< IdxRangeOnPatch, Patches... >, Mapping, ExecSpace >']]], - ['operator_28_29_1494',['operator()',['../classSplitVlasovSolver.html#ad980db982084e40e1777484ddc3312b0',1,'SplitVlasovSolver::operator()()'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a852a2a09220eabd3122cec7c741cacb2',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classLagrangeInterpolator.html#ac43d96b4a41419a6a1ff79a68c542be8',1,'LagrangeInterpolator::operator()()'],['../classIInterpolator.html#aaa5c3e3e3114ea37952ebe02f7464a00',1,'IInterpolator::operator()()'],['../classIPreallocatableInterpolator.html#a007978d119b0e00f003d12691bb1cf23',1,'IPreallocatableInterpolator::operator()()'],['../classSplineInterpolator.html#a9b9364a501a3bb3ea480b0d5617cd614',1,'SplineInterpolator::operator()()'],['../classMPITransposeAllToAll.html#a15010bf5fb9a21443c9812482eb18f77',1,'MPITransposeAllToAll::operator()()'],['../classEdgeTransformation.html#ade4e3d76c60e46f6d36a8f6fc9fd8f49',1,'EdgeTransformation::operator()(Coord< CurrentDim > const &current_coord) const'],['../classEdgeTransformation.html#a953cea3a043308fbce6a55438daf7376',1,'EdgeTransformation::operator()(CurrentIdx const &current_idx) const'],['../classOnionPatchLocator_3_01MultipatchType_3_01IdxRangeOnPatch_00_01Patches_8_8_8_01_4_00_01Mapping_00_01ExecSpace_01_4.html#ae26cedcd2f3684cba126c4d400065724',1,'OnionPatchLocator< MultipatchType< IdxRangeOnPatch, Patches... >, Mapping, ExecSpace >::operator()()'],['../structConstantExtrapolationRuleOnion.html#a7949720967a9f6332b6cdf3edc16d6d8',1,'ConstantExtrapolationRuleOnion::operator()()'],['../classMultipatchSplineBuilder.html#a0e9a0659e97da24ba0e5f71939ace8f6',1,'MultipatchSplineBuilder::operator()()'],['../classMultipatchSplineBuilder2D.html#aa348d62045660886c7d1d5b6798f475c',1,'MultipatchSplineBuilder2D::operator()()'],['../classMultipatchSplineEvaluator2D.html#a6d3f057e123cd847109fae5a4e190149',1,'MultipatchSplineEvaluator2D::operator()(Coord const coord_eval, MultipatchSplineCoeff const &patches_splines) const'],['../classMultipatchSplineEvaluator2D.html#aaecde8a4cb5fccb1f10dadf7a09b4300',1,'MultipatchSplineEvaluator2D::operator()(MultipatchValues const &patches_values, MultipatchCoordField const &patches_coords, MultipatchSplineCoeff const &patches_splines) const'],['../structNullExtrapolationRule.html#afff2dfac58dbcfcc760da499bb23b953',1,'NullExtrapolationRule::operator()()'],['../classFEM1DPoissonSolver.html#a74360fade3d3986423b148334d88ea74',1,'FEM1DPoissonSolver::operator()(field_type phi, field_type rho) const override'],['../classFEM1DPoissonSolver.html#a066aa2568bdfd946f04c1d831debd663',1,'FEM1DPoissonSolver::operator()(field_type phi, vector_field_type E, field_type rho) const override'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a4bb7415769d706c9b48d3a66efd76c71',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classFluidMoments.html#aeb2a3f97d8a00b2c5eed9df9e1317fd7',1,'FluidMoments::operator()()'],['../classIInitialization.html#a6fd840a3367ef39aed60a036fc196618',1,'IInitialization::operator()()'],['../classBslAdvection1D.html#ab6c09fdec0ac2ec060d846a03a775766',1,'BslAdvection1D::operator()()'],['../classFluidMoments.html#a2ae74d24f0db28d93e39b88d885b90cd',1,'FluidMoments::operator()(DFieldSpX density, DConstFieldSpXVx allfdistribu, MomentDensity moment_density)'],['../classFluidMoments.html#a4ab19d391047e94ce2dcc8e73bf94faa',1,'FluidMoments::operator()(double &mean_velocity, DConstFieldVx fdistribu, double density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a60e881623a1a0db3245c690b4d7cc27f',1,'FluidMoments::operator()(DFieldSpX mean_velocity, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a180dd355d3d536623a0393c243af58d3',1,'FluidMoments::operator()(double &temperature, DConstFieldVx fdistribu, double density, double mean_velocity, MomentTemperature moment_temperature)'],['../classFluidMoments.html#ac15b6dd021fe761a18301a5475035aae',1,'FluidMoments::operator()(DFieldSpX temperature, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, DConstFieldSpX mean_velocity, MomentTemperature moment_temperature)'],['../classKelvinHelmholtzInstabilityInitialization.html#a7e681122586f70b241acc2c647cf2f67',1,'KelvinHelmholtzInstabilityInitialization::operator()()'],['../classPredCorrRK2XY.html#a03ce8460021646ecb76554cbb4f1b088',1,'PredCorrRK2XY::operator()()'],['../classIEquilibrium.html#ac3766d5ef01c1e949ec3dd6d55892a75',1,'IEquilibrium::operator()()'],['../classIVlasovSolver.html#ae2c2b1a0762d06fe0beba20613003bff',1,'IVlasovSolver::operator()()'],['../classMaxwellianEquilibrium.html#a883dfc9d838b53deeb47e93f178c7655',1,'MaxwellianEquilibrium::operator()()'],['../classSingleModePerturbInitialization.html#abcef02302c35de979ca2d34d5f4b5b8f',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a7ad6d91143f3e31e3ed8318a9970ef8e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a14a845fbe0e835ff765a33611f09bd8b',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a4df01b6445f6c8dc356ebce808102115',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#af216cca80bf1989bb5031c640b6e3db1',1,'NullQNSolver::operator()()'],['../classQNSolver.html#a7a295c1742a016b2f154a35a315a608c',1,'QNSolver::operator()()'],['../classITimeSolver.html#a66cc73d3765db94df87fc17cc215c01b',1,'ITimeSolver::operator()()'],['../classPredCorr.html#afbad5baf6bfcce5c48b0cd47ce1de29d',1,'PredCorr::operator()()'],['../classMetricTensor.html#afa4a1d1ac34eb5fc3a2464d3844151fe',1,'MetricTensor::operator()()'],['../classCartesianToBarycentricCoordinates.html#a5ca03e3d3d4f19dbc155224de01628b0',1,'CartesianToBarycentricCoordinates::operator()()'],['../classCircularToCartesian.html#a849aafcfea9f2c4c2e89ca2f75146fc1',1,'CircularToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCircularToCartesian.html#ab5e802ee75b64d7312855e6a3bc5e23e',1,'CircularToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classCoordinateConverter.html#a4e7ef7ef5ff4be5859b156ea9275b083',1,'CoordinateConverter::operator()()'],['../classCzarnyToCartesian.html#ad28940b525c4b28f87adfee86285dce7',1,'CzarnyToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCzarnyToCartesian.html#a1de36110060cd5b600e737390eb99150',1,'CzarnyToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classDiscreteToCartesianBuilder.html#ab1184f5129d2eb56b886bbd87bc6c455',1,'DiscreteToCartesianBuilder::operator()()'],['../classRefinedDiscreteToCartesianBuilder.html#a9f3e0871397a545472332eab2bc71e89',1,'RefinedDiscreteToCartesianBuilder::operator()()'],['../classDiscreteToCartesian.html#ad065663545d04ef95605491b2a623f71',1,'DiscreteToCartesian::operator()()'],['../classCartesianToBarycentricCoordinates.html#ae50d67d32dd5d0ba69ca7d0972d34fda',1,'CartesianToBarycentricCoordinates::operator()()'],['../classPolarSplineEvaluator.html#a648c0a6d88caf58e87f2f0c3101a7102',1,'PolarSplineEvaluator::operator()(ddc::Coordinate< DimR, DimTheta > coord_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classPolarSplineEvaluator.html#ad457a95e0b533ac37f258898c707ad7c',1,'PolarSplineEvaluator::operator()(ddc::ChunkSpan< double, Domain > const spline_eval, ddc::ChunkSpan< ddc::Coordinate< DimR, DimTheta > const, Domain > const coords_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classCosineEvaluator_1_1Evaluator.html#aa66ae25f58a330dd6669a09d0e6dee6c',1,'CosineEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classCosineEvaluator_1_1Evaluator.html#a9646ec811ec36ef5ea200ac2a1fc20ed',1,'CosineEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classEvaluator2D_1_1Evaluator.html#a2f34faff2f95045b3d0d0bda617b7ff4',1,'Evaluator2D::Evaluator::operator()(double const x, double const y) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a52c53285c56d8a940f5edd13c05eb040',1,'Evaluator2D::Evaluator::operator()(ddc::Coordinate< Grid1, Grid2 > const x) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a4e55b2215bc57bea73fa93988f9d7784',1,'Evaluator2D::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1, Grid2 >> chunk) const'],['../classPolynomialEvaluator_1_1Evaluator.html#a6d682cf47c575b13250525acff8a1d97',1,'PolynomialEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classPolynomialEvaluator_1_1Evaluator.html#a7e0f1582d25f41381bc18b9c0fcb74f4',1,'PolynomialEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classAdvectionField__translation.html#afd102ec3e9ce04fa1d0a38643525eb8d',1,'AdvectionField_translation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a1d7f488b18c1e625a847115976c1cef8',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classQuadrature.html#acc3a757e91e2d185ee290c409156fd4f',1,'Quadrature::operator()(ExecutionSpace exec_space, IntegratorFunction integrated_function) const'],['../classQuadrature.html#a5a7011a414f2f78524042fd2104342f0',1,'Quadrature::operator()(ExecutionSpace exec_space, Field< double, BatchIdxRange, std::experimental::layout_right, MemorySpace > const result, IntegratorFunction integrated_function) const'],['../classGridBuilder.html#a9b022df3951111963099676b1a580dc5',1,'GridBuilder::operator()()'],['../classFunctionToBeAdvected.html#ac469846a7162037505e058f7d248dc4b',1,'FunctionToBeAdvected::operator()()'],['../classFunctionToBeAdvected__cos__4__elipse.html#a2f35b8a7024c4e1e1d0a09e761abf56e',1,'FunctionToBeAdvected_cos_4_elipse::operator()()'],['../classFunctionToBeAdvected__gaussian.html#a5cefc067d3394e546900673571f6e612',1,'FunctionToBeAdvected_gaussian::operator()()'],['../classAdvectionField.html#ad83cd6e152724ab1c8e91be077eb5727',1,'AdvectionField::operator()()'],['../classAdvectionField__decentred__rotation.html#aaabb7b2f3ae0f6aadaa1b5e3a7d1a94f',1,'AdvectionField_decentred_rotation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a75d1a09001829464626a080c1ffa2f68',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classAdvectionField__rotation.html#a4dc539810d2d10aa68104841574802cf',1,'AdvectionField_rotation::operator()()'],['../classElectrostaticalPotentialSimulation.html#a445037f02ef92015762871398e8fd471',1,'ElectrostaticalPotentialSimulation::operator()()'],['../classElectrostaticalPotentialSimulation__decentred__rotation.html#a0a5322b2df29b69ab4c5438b5b0207af',1,'ElectrostaticalPotentialSimulation_decentred_rotation::operator()()'],['../classElectrostaticalPotentialSimulation__translation.html#ab42dce0f7ac411db86c2dd9871537189',1,'ElectrostaticalPotentialSimulation_translation::operator()()'],['../classElectrostaticalPotentialSimulation__rotation.html#af3f3c3819cbc815aa2a272028ef24fcd',1,'ElectrostaticalPotentialSimulation_rotation::operator()()'],['../classPoissonSolution.html#a88e27ab5b89c3992369e44ca7ecb56de',1,'PoissonSolution::operator()()'],['../classCurvilinearSolution.html#a88ec8a5cb7ec05b1abb9e9347016ea42',1,'CurvilinearSolution::operator()()'],['../classCartesianSolution.html#a0153345ef0de946e25e0bad9a68cc8dd',1,'CartesianSolution::operator()()'],['../classManufacturedPoissonTest.html#a88bc41fa060076c0477a808ac4395b79',1,'ManufacturedPoissonTest::operator()()'],['../classPoissonLikeRHSFunction.html#a87f656365ccc4fe8d8fb650c0264679a',1,'PoissonLikeRHSFunction::operator()()'],['../classAdvectionFieldFinder.html#a25dbc5a3703a7c81ca3f48b2ba8cb504',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a0411b8564a15c52c7374a419c33c7962',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a627c1dcadd341f200e312384b8ca3a52',1,'AdvectionFieldFinder::operator()(host_t< DFieldRTheta > electrostatic_potential, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#a127493f100ee2ebced546e80b3791662',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#aa272e8834000ff10dc7ce35d6d66de15',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classIInterpolatorRTheta.html#aced5e14f8fab92a58c72a12e563850ff',1,'IInterpolatorRTheta::operator()()'],['../classIPreallocatableInterpolatorRTheta.html#a46845d7c3ff21e134629490f4e879f3a',1,'IPreallocatableInterpolatorRTheta::operator()()'],['../classSplineInterpolatorRTheta.html#a49e46f474710a43e2c8d0d49491f16f4',1,'SplineInterpolatorRTheta::operator()()'],['../classIQNSolver.html#ae11bcffd844aeadf69c5ff2e1e0305b6',1,'IQNSolver::operator()()'],['../classAdvectionFieldFinder.html#a16ae332726478b50a6234b22b9ab977e',1,'AdvectionFieldFinder::operator()()'],['../classPolarSplineFEMPoissonLikeSolver.html#a208c1aab7d91aedcbe30231a46979c49',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, SplinePolar &spline) const'],['../classPolarSplineFEMPoissonLikeSolver.html#aa674e69e7db91ebbe8c0862fda157232',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, host_t< ConstFieldRTheta< CoordRTheta >> const coords_eval, host_t< DFieldRTheta > result) const'],['../classBslPredCorrRTheta.html#afcf39ab7a2574a1f4bb644d74347a84b',1,'BslPredCorrRTheta::operator()()'],['../classBslExplicitPredCorrRTheta.html#a4a0d13a36c04660e9416fd8dba361e43',1,'BslExplicitPredCorrRTheta::operator()()'],['../classBslImplicitPredCorrRTheta.html#ac3d7835dd0c995e3a9ecaa49474fc657',1,'BslImplicitPredCorrRTheta::operator()()'],['../classITimeSolverRTheta.html#a6b757c78184c80859037e523cac13e31',1,'ITimeSolverRTheta::operator()()'],['../classIEquilibrium.html#a58d9872d82ccadfbb3f215528463e30d',1,'IEquilibrium::operator()()'],['../classIInitialization.html#a6588f6592eaceff813dd509afce2d052',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#a0a2a1b781c2e521696ffc22c02d52282',1,'MaxwellianEquilibrium::operator()()'],['../classVectorField.html#a97f23f71edd98dd8adb12184b1ccead6',1,'VectorField::operator()()'],['../classBslAdvectionVelocity.html#ad1278ae4fb0647b24ca667c123bb3e36',1,'BslAdvectionVelocity::operator()()'],['../classBslAdvectionSpatial.html#a7179641516b4b75751638b5b905493e8',1,'BslAdvectionSpatial::operator()()'],['../classIAdvectionVelocity.html#af3daea164fd82a838975ff5dddf43676',1,'IAdvectionVelocity::operator()()'],['../classIAdvectionSpatial.html#a32a848ebf7598f793c50f515c9190452',1,'IAdvectionSpatial::operator()()'],['../classNullAdvectionVelocity.html#ad75024862512241516864edf382b14c0',1,'NullAdvectionVelocity::operator()()'],['../classCollisionSpVparMu.html#a87ae0a4bf2125a89b0f5235d6217b545',1,'CollisionSpVparMu::operator()()'],['../classDerivField_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01LayoutStridedPolicy_00_01MemorySpace_01_4.html#a378ab989db882557227b0e71eed8c4d8',1,'DerivField< ElementType, IdxRange< DDims... >, LayoutStridedPolicy, MemorySpace >::operator()()'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#ad75d8f24cde91009e1e0e80f0ceae224',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()(DElem... elems) noexcept'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#a14eaae81de1dcc49042634831a47ec9f',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()(DElem... elems) const noexcept'],['../classITimeSolverHybrid.html#aa65ff6d73a2a7a97aeed15dab0ab3d94',1,'ITimeSolverHybrid::operator()()'],['../classVectorField.html#a8dc232b7be4d650ac49cf52208aaca6c',1,'VectorField::operator()()'],['../classVectorFieldMem.html#a0b2e8ceb5595ef98d07d42d12b41601d',1,'VectorFieldMem::operator()(Idx< ODDims > const &... delems) const noexcept'],['../classVectorFieldMem.html#ab9430bd40d0b0924dc2a5735617483a5',1,'VectorFieldMem::operator()(Idx< ODDims... > const &delems) const noexcept'],['../classBslAdvectionRTheta.html#a4304e54db2d9ca10f3c57b358299427e',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field_xy, double dt) const'],['../classBslAdvectionRTheta.html#a2a0284e6fcae81c7f98cceade91494a8',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY const &advection_field_xy_center, double dt) const'],['../classIAdvectionRTheta.html#a4f626c6b5ce9b190f5b80d09384938f5',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field, double const dt) const =0'],['../classIAdvectionRTheta.html#a1dc3db8c2963ef6baf81ea1b3432bb10',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field, CoordXY const &advection_field_xy_center, double const dt) const =0'],['../classIFootFinder.html#a4b4e64d793fc6cd63e5771f3ebf89308',1,'IFootFinder::operator()()'],['../classSplineFootFinder.html#a0419e33b71f3551fc03d84ac9f669141',1,'SplineFootFinder::operator()()'],['../classQNSolver.html#a866ea0a8cd34e7789d8847aaf963fdf2',1,'QNSolver::operator()()'],['../classIEquilibrium.html#a3ea3adf00a9a416a8e3fe54caba902a4',1,'IEquilibrium::operator()()'],['../classIInitialization.html#ac70366059a8d5679ff45c1a3eed5ad6b',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#af3b41f93de3bb96ae0b44d8f89ee2a0a',1,'MaxwellianEquilibrium::operator()()'],['../classRestartInitialization.html#adb0bfb34f2397f95e8d559e5b04222b8',1,'RestartInitialization::operator()()'],['../classSingleModePerturbInitialization.html#a6fe8be7de3eefd844b3f15e7d50b1707',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a164ef05aba41f41d7862c1aa216c154e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a33642031ef4d350e865b9b3d81f6bc76',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a0a2d3c31695c821a43582f1c2cd4e928',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#ac636ac6b797e8bf883a53955f191d4ed',1,'NullQNSolver::operator()()'],['../classIInitialization.html#abc23a07c3e1a7852b4be401e57526061',1,'IInitialization::operator()()'],['../classCollisionsInter.html#a1f8104eb5930b71b25856a0640c534bf',1,'CollisionsInter::operator()()'],['../classCollisionsIntra.html#ad066a79f6c0a9dcf3720dbfc5e9056e0',1,'CollisionsIntra::operator()()'],['../classIRightHandSide.html#a00f66ff88f6b0fd17a931a09b1ddb2d3',1,'IRightHandSide::operator()()'],['../classKineticSource.html#a384f4c655ebe246d99964de77ee780d2',1,'KineticSource::operator()()'],['../classKrookSourceAdaptive.html#a1f7a6ce3a4f5f93214352a4787ba7888',1,'KrookSourceAdaptive::operator()()'],['../classKrookSourceConstant.html#a266237a1a58a6f8f000ee4e910353dcc',1,'KrookSourceConstant::operator()()'],['../classITimeSolver.html#abfdecd652433d1ae388a6489da2ed865',1,'ITimeSolver::operator()()'],['../classPredCorr.html#a2a3c70566fbfaef1d04bb540c980e7d1',1,'PredCorr::operator()()'],['../classPredCorrHybrid.html#a6bfe0fdcbcc66b657bb0598cd4a1135c',1,'PredCorrHybrid::operator()()'],['../classRecombinationRate.html#afc0642ee5f185d34df820b67d3b360e9',1,'RecombinationRate::operator()()'],['../classBumpontailEquilibrium.html#a4c85a379ea216bb7ac95186cf8af8817',1,'BumpontailEquilibrium::operator()()'],['../classIEquilibrium.html#a425f7b104d75900fcc769bdee9c0cdbd',1,'IEquilibrium::operator()()'],['../classMaxwellianEquilibrium.html#a0cc2b9bdb6300dd5661cedbfc27957b3',1,'MaxwellianEquilibrium::operator()()'],['../classNoPerturbInitialization.html#a7debfeb8001108b1fb6d431ecf98a19e',1,'NoPerturbInitialization::operator()()'],['../classIBoltzmannSolver.html#aedf19fb0ae7e0bf80729c9f761ee20ed',1,'IBoltzmannSolver::operator()()'],['../classSplitRightHandSideSolver.html#a350971eed31753861f6e2917b9b6b968',1,'SplitRightHandSideSolver::operator()()'],['../classSplitVlasovSolver.html#a958b142757ef330191c9c25188294f15',1,'SplitVlasovSolver::operator()()'],['../classConstantFluidInitialization.html#a1fbff918b2671a42ea378127f1223708',1,'ConstantFluidInitialization::operator()()'],['../classIFluidInitialization.html#ac61ad3c8aec9bc3b1bd40998dee90e2c',1,'IFluidInitialization::operator()()'],['../classIFluidTransportSolver.html#a7b533a63875dcba416c647dfab0dd7eb',1,'IFluidTransportSolver::operator()()'],['../classNullFluidSolver.html#a57df0286d899f8278d9147aeea564292',1,'NullFluidSolver::operator()()'],['../classIKineticFluidCoupling.html#a915230ecc7ba3faffc9279f0283bb0b3',1,'IKineticFluidCoupling::operator()()'],['../classKineticFluidCouplingSource.html#a8d185066590f530d132ecfd4d4b315be',1,'KineticFluidCouplingSource::operator()()'],['../classChargeExchangeRate.html#a73b415cda84b9f40a85da1d4f5d377b4',1,'ChargeExchangeRate::operator()()'],['../classConstantRate.html#ada12e13f0c3e2b98cb5b2c35a21be9b9',1,'ConstantRate::operator()()'],['../classIonizationRate.html#a04169db7340af25ff0c760184148c81a',1,'IonizationRate::operator()()'],['../classIReactionRate.html#aa53dd629fec8987317cc634bb52d7fe3',1,'IReactionRate::operator()()'],['../classDiffusiveNeutralSolver.html#af44bb1d70fd2a551ed4fc7008b564d5b',1,'DiffusiveNeutralSolver::operator()()']]], + ['operator_28_29_1494',['operator()',['../classSplitVlasovSolver.html#ad980db982084e40e1777484ddc3312b0',1,'SplitVlasovSolver::operator()()'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a852a2a09220eabd3122cec7c741cacb2',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classLagrangeInterpolator.html#ac43d96b4a41419a6a1ff79a68c542be8',1,'LagrangeInterpolator::operator()()'],['../classIInterpolator.html#aaa5c3e3e3114ea37952ebe02f7464a00',1,'IInterpolator::operator()()'],['../classIPreallocatableInterpolator.html#a007978d119b0e00f003d12691bb1cf23',1,'IPreallocatableInterpolator::operator()()'],['../classSplineInterpolator.html#a9b9364a501a3bb3ea480b0d5617cd614',1,'SplineInterpolator::operator()()'],['../classMPITransposeAllToAll.html#a15010bf5fb9a21443c9812482eb18f77',1,'MPITransposeAllToAll::operator()()'],['../classEdgeTransformation.html#ade4e3d76c60e46f6d36a8f6fc9fd8f49',1,'EdgeTransformation::operator()(Coord< CurrentDim > const &current_coord) const'],['../classEdgeTransformation.html#a953cea3a043308fbce6a55438daf7376',1,'EdgeTransformation::operator()(CurrentIdx const &current_idx) const'],['../classOnionPatchLocator_3_01MultipatchType_3_01IdxRangeOnPatch_00_01Patches_8_8_8_01_4_00_01Mapping_00_01ExecSpace_01_4.html#ae26cedcd2f3684cba126c4d400065724',1,'OnionPatchLocator< MultipatchType< IdxRangeOnPatch, Patches... >, Mapping, ExecSpace >::operator()()'],['../structConstantExtrapolationRuleOnion.html#a7949720967a9f6332b6cdf3edc16d6d8',1,'ConstantExtrapolationRuleOnion::operator()()'],['../classMultipatchSplineBuilder.html#a0e9a0659e97da24ba0e5f71939ace8f6',1,'MultipatchSplineBuilder::operator()()'],['../classMultipatchSplineBuilder2D.html#aa348d62045660886c7d1d5b6798f475c',1,'MultipatchSplineBuilder2D::operator()()'],['../classMultipatchSplineEvaluator2D.html#a6d3f057e123cd847109fae5a4e190149',1,'MultipatchSplineEvaluator2D::operator()(Coord const coord_eval, MultipatchSplineCoeff const &patches_splines) const'],['../classMultipatchSplineEvaluator2D.html#aaecde8a4cb5fccb1f10dadf7a09b4300',1,'MultipatchSplineEvaluator2D::operator()(MultipatchValues const &patches_values, MultipatchCoordField const &patches_coords, MultipatchSplineCoeff const &patches_splines) const'],['../structNullExtrapolationRule.html#afff2dfac58dbcfcc760da499bb23b953',1,'NullExtrapolationRule::operator()()'],['../classFEM1DPoissonSolver.html#a74360fade3d3986423b148334d88ea74',1,'FEM1DPoissonSolver::operator()(field_type phi, field_type rho) const override'],['../classFEM1DPoissonSolver.html#a066aa2568bdfd946f04c1d831debd663',1,'FEM1DPoissonSolver::operator()(field_type phi, vector_field_type E, field_type rho) const override'],['../classFFTPoissonSolver_3_01IdxRange_3_01GridPDEDim1D_8_8_8_01_4_00_01IdxRangeFull_00_01ExecSpace_00_01LayoutSpace_01_4.html#a4bb7415769d706c9b48d3a66efd76c71',1,'FFTPoissonSolver< IdxRange< GridPDEDim1D... >, IdxRangeFull, ExecSpace, LayoutSpace >::operator()()'],['../classFluidMoments.html#aeb2a3f97d8a00b2c5eed9df9e1317fd7',1,'FluidMoments::operator()()'],['../classIInitialization.html#a6fd840a3367ef39aed60a036fc196618',1,'IInitialization::operator()()'],['../classBslAdvection1D.html#ab6c09fdec0ac2ec060d846a03a775766',1,'BslAdvection1D::operator()()'],['../classFluidMoments.html#a2ae74d24f0db28d93e39b88d885b90cd',1,'FluidMoments::operator()(DFieldSpX density, DConstFieldSpXVx allfdistribu, MomentDensity moment_density)'],['../classFluidMoments.html#a4ab19d391047e94ce2dcc8e73bf94faa',1,'FluidMoments::operator()(double &mean_velocity, DConstFieldVx fdistribu, double density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a60e881623a1a0db3245c690b4d7cc27f',1,'FluidMoments::operator()(DFieldSpX mean_velocity, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, MomentVelocity moment_velocity)'],['../classFluidMoments.html#a180dd355d3d536623a0393c243af58d3',1,'FluidMoments::operator()(double &temperature, DConstFieldVx fdistribu, double density, double mean_velocity, MomentTemperature moment_temperature)'],['../classFluidMoments.html#ac15b6dd021fe761a18301a5475035aae',1,'FluidMoments::operator()(DFieldSpX temperature, DConstFieldSpXVx allfdistribu, DConstFieldSpX density, DConstFieldSpX mean_velocity, MomentTemperature moment_temperature)'],['../classKelvinHelmholtzInstabilityInitialization.html#a7e681122586f70b241acc2c647cf2f67',1,'KelvinHelmholtzInstabilityInitialization::operator()()'],['../classPredCorrRK2XY.html#a03ce8460021646ecb76554cbb4f1b088',1,'PredCorrRK2XY::operator()()'],['../classIEquilibrium.html#ac3766d5ef01c1e949ec3dd6d55892a75',1,'IEquilibrium::operator()()'],['../classIVlasovSolver.html#ae2c2b1a0762d06fe0beba20613003bff',1,'IVlasovSolver::operator()()'],['../classMaxwellianEquilibrium.html#a883dfc9d838b53deeb47e93f178c7655',1,'MaxwellianEquilibrium::operator()()'],['../classSingleModePerturbInitialization.html#abcef02302c35de979ca2d34d5f4b5b8f',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a7ad6d91143f3e31e3ed8318a9970ef8e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a14a845fbe0e835ff765a33611f09bd8b',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a4df01b6445f6c8dc356ebce808102115',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#af216cca80bf1989bb5031c640b6e3db1',1,'NullQNSolver::operator()()'],['../classQNSolver.html#a7a295c1742a016b2f154a35a315a608c',1,'QNSolver::operator()()'],['../classITimeSolver.html#a66cc73d3765db94df87fc17cc215c01b',1,'ITimeSolver::operator()()'],['../classPredCorr.html#afbad5baf6bfcce5c48b0cd47ce1de29d',1,'PredCorr::operator()()'],['../classMetricTensor.html#afa4a1d1ac34eb5fc3a2464d3844151fe',1,'MetricTensor::operator()()'],['../classCartesianToBarycentricCoordinates.html#a5ca03e3d3d4f19dbc155224de01628b0',1,'CartesianToBarycentricCoordinates::operator()()'],['../classCircularToCartesian.html#a849aafcfea9f2c4c2e89ca2f75146fc1',1,'CircularToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCircularToCartesian.html#ab5e802ee75b64d7312855e6a3bc5e23e',1,'CircularToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classCoordinateConverter.html#a4e7ef7ef5ff4be5859b156ea9275b083',1,'CoordinateConverter::operator()()'],['../classCzarnyToCartesian.html#ad28940b525c4b28f87adfee86285dce7',1,'CzarnyToCartesian::operator()(ddc::Coordinate< R, Theta > const &coord) const final'],['../classCzarnyToCartesian.html#a1de36110060cd5b600e737390eb99150',1,'CzarnyToCartesian::operator()(ddc::Coordinate< X, Y > const &coord) const final'],['../classDiscreteToCartesianBuilder.html#ab1184f5129d2eb56b886bbd87bc6c455',1,'DiscreteToCartesianBuilder::operator()()'],['../classRefinedDiscreteToCartesianBuilder.html#a9f3e0871397a545472332eab2bc71e89',1,'RefinedDiscreteToCartesianBuilder::operator()()'],['../classDiscreteToCartesian.html#ad065663545d04ef95605491b2a623f71',1,'DiscreteToCartesian::operator()()'],['../classCartesianToBarycentricCoordinates.html#ae50d67d32dd5d0ba69ca7d0972d34fda',1,'CartesianToBarycentricCoordinates::operator()()'],['../classPolarSplineEvaluator.html#a648c0a6d88caf58e87f2f0c3101a7102',1,'PolarSplineEvaluator::operator()(ddc::Coordinate< DimR, DimTheta > coord_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classPolarSplineEvaluator.html#ad457a95e0b533ac37f258898c707ad7c',1,'PolarSplineEvaluator::operator()(ddc::ChunkSpan< double, Domain > const spline_eval, ddc::ChunkSpan< ddc::Coordinate< DimR, DimTheta > const, Domain > const coords_eval, PolarSplineView< PolarBSplinesType > const spline_coef) const'],['../classCosineEvaluator_1_1Evaluator.html#aa66ae25f58a330dd6669a09d0e6dee6c',1,'CosineEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classCosineEvaluator_1_1Evaluator.html#a9646ec811ec36ef5ea200ac2a1fc20ed',1,'CosineEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classEvaluator2D_1_1Evaluator.html#a2f34faff2f95045b3d0d0bda617b7ff4',1,'Evaluator2D::Evaluator::operator()(double const x, double const y) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a52c53285c56d8a940f5edd13c05eb040',1,'Evaluator2D::Evaluator::operator()(ddc::Coordinate< Grid1, Grid2 > const x) const noexcept'],['../classEvaluator2D_1_1Evaluator.html#a4e55b2215bc57bea73fa93988f9d7784',1,'Evaluator2D::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1, Grid2 >> chunk) const'],['../classPolynomialEvaluator_1_1Evaluator.html#a6d682cf47c575b13250525acff8a1d97',1,'PolynomialEvaluator::Evaluator::operator()(double const x) const noexcept'],['../classPolynomialEvaluator_1_1Evaluator.html#a7e0f1582d25f41381bc18b9c0fcb74f4',1,'PolynomialEvaluator::Evaluator::operator()(ddc::ChunkSpan< double, ddc::DiscreteDomain< Grid1D >> chunk) const'],['../classAdvectionField__translation.html#afd102ec3e9ce04fa1d0a38643525eb8d',1,'AdvectionField_translation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a1d7f488b18c1e625a847115976c1cef8',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classQuadrature.html#acc3a757e91e2d185ee290c409156fd4f',1,'Quadrature::operator()(ExecutionSpace exec_space, IntegratorFunction integrated_function) const'],['../classQuadrature.html#a5a7011a414f2f78524042fd2104342f0',1,'Quadrature::operator()(ExecutionSpace exec_space, Field< double, BatchIdxRange, std::experimental::layout_right, MemorySpace > const result, IntegratorFunction integrated_function) const'],['../classGridBuilder.html#a9b022df3951111963099676b1a580dc5',1,'GridBuilder::operator()()'],['../classFunctionToBeAdvected.html#ac469846a7162037505e058f7d248dc4b',1,'FunctionToBeAdvected::operator()()'],['../classFunctionToBeAdvected__cos__4__elipse.html#a2f35b8a7024c4e1e1d0a09e761abf56e',1,'FunctionToBeAdvected_cos_4_elipse::operator()()'],['../classFunctionToBeAdvected__gaussian.html#a5cefc067d3394e546900673571f6e612',1,'FunctionToBeAdvected_gaussian::operator()()'],['../classAdvectionField.html#ad83cd6e152724ab1c8e91be077eb5727',1,'AdvectionField::operator()()'],['../classAdvectionField__decentred__rotation.html#aaabb7b2f3ae0f6aadaa1b5e3a7d1a94f',1,'AdvectionField_decentred_rotation::operator()()'],['../classIPoissonSolver_3_01IdxRange_3_01ODims_8_8_8_01_4_00_01IdxRangeFull_00_01LayoutSpace_00_01MemorySpace_01_4.html#a75d1a09001829464626a080c1ffa2f68',1,'IPoissonSolver< IdxRange< ODims... >, IdxRangeFull, LayoutSpace, MemorySpace >::operator()()'],['../classAdvectionField__rotation.html#a4dc539810d2d10aa68104841574802cf',1,'AdvectionField_rotation::operator()()'],['../classElectrostaticalPotentialSimulation.html#a445037f02ef92015762871398e8fd471',1,'ElectrostaticalPotentialSimulation::operator()()'],['../classElectrostaticalPotentialSimulation__decentred__rotation.html#a0a5322b2df29b69ab4c5438b5b0207af',1,'ElectrostaticalPotentialSimulation_decentred_rotation::operator()()'],['../classElectrostaticalPotentialSimulation__translation.html#ab42dce0f7ac411db86c2dd9871537189',1,'ElectrostaticalPotentialSimulation_translation::operator()()'],['../classElectrostaticalPotentialSimulation__rotation.html#af3f3c3819cbc815aa2a272028ef24fcd',1,'ElectrostaticalPotentialSimulation_rotation::operator()()'],['../classPoissonSolution.html#a88e27ab5b89c3992369e44ca7ecb56de',1,'PoissonSolution::operator()()'],['../classCurvilinearSolution.html#a88ec8a5cb7ec05b1abb9e9347016ea42',1,'CurvilinearSolution::operator()()'],['../classCartesianSolution.html#a0153345ef0de946e25e0bad9a68cc8dd',1,'CartesianSolution::operator()()'],['../classManufacturedPoissonTest.html#a88bc41fa060076c0477a808ac4395b79',1,'ManufacturedPoissonTest::operator()()'],['../classPoissonLikeRHSFunction.html#a87f656365ccc4fe8d8fb650c0264679a',1,'PoissonLikeRHSFunction::operator()()'],['../classAdvectionFieldFinder.html#a25dbc5a3703a7c81ca3f48b2ba8cb504',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a0411b8564a15c52c7374a419c33c7962',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< X, Y >> advection_field_xy) const'],['../classAdvectionFieldFinder.html#a627c1dcadd341f200e312384b8ca3a52',1,'AdvectionFieldFinder::operator()(host_t< DFieldRTheta > electrostatic_potential, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#a127493f100ee2ebced546e80b3791662',1,'AdvectionFieldFinder::operator()(host_t< Spline2D > electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classAdvectionFieldFinder.html#aa272e8834000ff10dc7ce35d6d66de15',1,'AdvectionFieldFinder::operator()(SplinePolar &electrostatic_potential_coef, host_t< DVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY &advection_field_xy_center) const'],['../classIInterpolatorRTheta.html#aced5e14f8fab92a58c72a12e563850ff',1,'IInterpolatorRTheta::operator()()'],['../classIPreallocatableInterpolatorRTheta.html#a46845d7c3ff21e134629490f4e879f3a',1,'IPreallocatableInterpolatorRTheta::operator()()'],['../classSplineInterpolatorRTheta.html#a49e46f474710a43e2c8d0d49491f16f4',1,'SplineInterpolatorRTheta::operator()()'],['../classIQNSolver.html#ae11bcffd844aeadf69c5ff2e1e0305b6',1,'IQNSolver::operator()()'],['../classAdvectionFieldFinder.html#a16ae332726478b50a6234b22b9ab977e',1,'AdvectionFieldFinder::operator()()'],['../classPolarSplineFEMPoissonLikeSolver.html#a208c1aab7d91aedcbe30231a46979c49',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, SplinePolar &spline) const'],['../classPolarSplineFEMPoissonLikeSolver.html#aa674e69e7db91ebbe8c0862fda157232',1,'PolarSplineFEMPoissonLikeSolver::operator()(RHSFunction const &rhs, host_t< ConstFieldRTheta< CoordRTheta >> const coords_eval, host_t< DFieldRTheta > result) const'],['../classBslPredCorrRTheta.html#afcf39ab7a2574a1f4bb644d74347a84b',1,'BslPredCorrRTheta::operator()()'],['../classBslExplicitPredCorrRTheta.html#aaf7de730188384e04d3121a0aab47d95',1,'BslExplicitPredCorrRTheta::operator()()'],['../classBslImplicitPredCorrRTheta.html#ac3d7835dd0c995e3a9ecaa49474fc657',1,'BslImplicitPredCorrRTheta::operator()()'],['../classITimeSolverRTheta.html#a6b757c78184c80859037e523cac13e31',1,'ITimeSolverRTheta::operator()()'],['../classIEquilibrium.html#a58d9872d82ccadfbb3f215528463e30d',1,'IEquilibrium::operator()()'],['../classIInitialization.html#a6588f6592eaceff813dd509afce2d052',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#a0a2a1b781c2e521696ffc22c02d52282',1,'MaxwellianEquilibrium::operator()()'],['../classVectorField.html#a97f23f71edd98dd8adb12184b1ccead6',1,'VectorField::operator()()'],['../classBslAdvectionVelocity.html#ad1278ae4fb0647b24ca667c123bb3e36',1,'BslAdvectionVelocity::operator()()'],['../classBslAdvectionSpatial.html#a7179641516b4b75751638b5b905493e8',1,'BslAdvectionSpatial::operator()()'],['../classIAdvectionVelocity.html#af3daea164fd82a838975ff5dddf43676',1,'IAdvectionVelocity::operator()()'],['../classIAdvectionSpatial.html#a32a848ebf7598f793c50f515c9190452',1,'IAdvectionSpatial::operator()()'],['../classNullAdvectionVelocity.html#ad75024862512241516864edf382b14c0',1,'NullAdvectionVelocity::operator()()'],['../classCollisionSpVparMu.html#a87ae0a4bf2125a89b0f5235d6217b545',1,'CollisionSpVparMu::operator()()'],['../classDerivField_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01LayoutStridedPolicy_00_01MemorySpace_01_4.html#a378ab989db882557227b0e71eed8c4d8',1,'DerivField< ElementType, IdxRange< DDims... >, LayoutStridedPolicy, MemorySpace >::operator()()'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#ad75d8f24cde91009e1e0e80f0ceae224',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()(DElem... elems) noexcept'],['../classDerivFieldMem_3_01ElementType_00_01IdxRange_3_01DDims_8_8_8_01_4_00_01NDerivs_00_01MemSpace_01_4.html#a14eaae81de1dcc49042634831a47ec9f',1,'DerivFieldMem< ElementType, IdxRange< DDims... >, NDerivs, MemSpace >::operator()(DElem... elems) const noexcept'],['../classITimeSolverHybrid.html#aa65ff6d73a2a7a97aeed15dab0ab3d94',1,'ITimeSolverHybrid::operator()()'],['../classVectorField.html#a8dc232b7be4d650ac49cf52208aaca6c',1,'VectorField::operator()()'],['../classVectorFieldMem.html#a0b2e8ceb5595ef98d07d42d12b41601d',1,'VectorFieldMem::operator()(Idx< ODDims > const &... delems) const noexcept'],['../classVectorFieldMem.html#ab9430bd40d0b0924dc2a5735617483a5',1,'VectorFieldMem::operator()(Idx< ODDims... > const &delems) const noexcept'],['../classBslAdvectionRTheta.html#a4304e54db2d9ca10f3c57b358299427e',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field_xy, double dt) const'],['../classBslAdvectionRTheta.html#a2a0284e6fcae81c7f98cceade91494a8',1,'BslAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field_rp, CoordXY const &advection_field_xy_center, double dt) const'],['../classIAdvectionRTheta.html#a4f626c6b5ce9b190f5b80d09384938f5',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< X, Y >> advection_field, double const dt) const =0'],['../classIAdvectionRTheta.html#a1dc3db8c2963ef6baf81ea1b3432bb10',1,'IAdvectionRTheta::operator()(host_t< DFieldRTheta > allfdistribu, host_t< DConstVectorFieldRTheta< R, Theta >> advection_field, CoordXY const &advection_field_xy_center, double const dt) const =0'],['../classIFootFinder.html#a4b4e64d793fc6cd63e5771f3ebf89308',1,'IFootFinder::operator()()'],['../classSplineFootFinder.html#a0419e33b71f3551fc03d84ac9f669141',1,'SplineFootFinder::operator()()'],['../classQNSolver.html#a866ea0a8cd34e7789d8847aaf963fdf2',1,'QNSolver::operator()()'],['../classIEquilibrium.html#a3ea3adf00a9a416a8e3fe54caba902a4',1,'IEquilibrium::operator()()'],['../classIInitialization.html#ac70366059a8d5679ff45c1a3eed5ad6b',1,'IInitialization::operator()()'],['../classMaxwellianEquilibrium.html#af3b41f93de3bb96ae0b44d8f89ee2a0a',1,'MaxwellianEquilibrium::operator()()'],['../classRestartInitialization.html#adb0bfb34f2397f95e8d559e5b04222b8',1,'RestartInitialization::operator()()'],['../classSingleModePerturbInitialization.html#a6fe8be7de3eefd844b3f15e7d50b1707',1,'SingleModePerturbInitialization::operator()()'],['../classChargeDensityCalculator.html#a164ef05aba41f41d7862c1aa216c154e',1,'ChargeDensityCalculator::operator()()'],['../classIChargeDensityCalculator.html#a33642031ef4d350e865b9b3d81f6bc76',1,'IChargeDensityCalculator::operator()()'],['../classIQNSolver.html#a0a2d3c31695c821a43582f1c2cd4e928',1,'IQNSolver::operator()()'],['../classNullQNSolver.html#ac636ac6b797e8bf883a53955f191d4ed',1,'NullQNSolver::operator()()'],['../classIInitialization.html#abc23a07c3e1a7852b4be401e57526061',1,'IInitialization::operator()()'],['../classCollisionsInter.html#a1f8104eb5930b71b25856a0640c534bf',1,'CollisionsInter::operator()()'],['../classCollisionsIntra.html#ad066a79f6c0a9dcf3720dbfc5e9056e0',1,'CollisionsIntra::operator()()'],['../classIRightHandSide.html#a00f66ff88f6b0fd17a931a09b1ddb2d3',1,'IRightHandSide::operator()()'],['../classKineticSource.html#a384f4c655ebe246d99964de77ee780d2',1,'KineticSource::operator()()'],['../classKrookSourceAdaptive.html#a1f7a6ce3a4f5f93214352a4787ba7888',1,'KrookSourceAdaptive::operator()()'],['../classKrookSourceConstant.html#a266237a1a58a6f8f000ee4e910353dcc',1,'KrookSourceConstant::operator()()'],['../classITimeSolver.html#abfdecd652433d1ae388a6489da2ed865',1,'ITimeSolver::operator()()'],['../classPredCorr.html#a2a3c70566fbfaef1d04bb540c980e7d1',1,'PredCorr::operator()()'],['../classPredCorrHybrid.html#a6bfe0fdcbcc66b657bb0598cd4a1135c',1,'PredCorrHybrid::operator()()'],['../classRecombinationRate.html#afc0642ee5f185d34df820b67d3b360e9',1,'RecombinationRate::operator()()'],['../classBumpontailEquilibrium.html#a4c85a379ea216bb7ac95186cf8af8817',1,'BumpontailEquilibrium::operator()()'],['../classIEquilibrium.html#a425f7b104d75900fcc769bdee9c0cdbd',1,'IEquilibrium::operator()()'],['../classMaxwellianEquilibrium.html#a0cc2b9bdb6300dd5661cedbfc27957b3',1,'MaxwellianEquilibrium::operator()()'],['../classNoPerturbInitialization.html#a7debfeb8001108b1fb6d431ecf98a19e',1,'NoPerturbInitialization::operator()()'],['../classIBoltzmannSolver.html#aedf19fb0ae7e0bf80729c9f761ee20ed',1,'IBoltzmannSolver::operator()()'],['../classSplitRightHandSideSolver.html#a350971eed31753861f6e2917b9b6b968',1,'SplitRightHandSideSolver::operator()()'],['../classSplitVlasovSolver.html#a958b142757ef330191c9c25188294f15',1,'SplitVlasovSolver::operator()()'],['../classConstantFluidInitialization.html#a1fbff918b2671a42ea378127f1223708',1,'ConstantFluidInitialization::operator()()'],['../classIFluidInitialization.html#ac61ad3c8aec9bc3b1bd40998dee90e2c',1,'IFluidInitialization::operator()()'],['../classIFluidTransportSolver.html#a7b533a63875dcba416c647dfab0dd7eb',1,'IFluidTransportSolver::operator()()'],['../classNullFluidSolver.html#a57df0286d899f8278d9147aeea564292',1,'NullFluidSolver::operator()()'],['../classIKineticFluidCoupling.html#a915230ecc7ba3faffc9279f0283bb0b3',1,'IKineticFluidCoupling::operator()()'],['../classKineticFluidCouplingSource.html#a8d185066590f530d132ecfd4d4b315be',1,'KineticFluidCouplingSource::operator()()'],['../classChargeExchangeRate.html#a73b415cda84b9f40a85da1d4f5d377b4',1,'ChargeExchangeRate::operator()()'],['../classConstantRate.html#ada12e13f0c3e2b98cb5b2c35a21be9b9',1,'ConstantRate::operator()()'],['../classIonizationRate.html#a04169db7340af25ff0c760184148c81a',1,'IonizationRate::operator()()'],['../classIReactionRate.html#aa53dd629fec8987317cc634bb52d7fe3',1,'IReactionRate::operator()()'],['../classDiffusiveNeutralSolver.html#af44bb1d70fd2a551ed4fc7008b564d5b',1,'DiffusiveNeutralSolver::operator()()']]], ['operator_2a_1495',['operator*',['../structIdxRangeSliceIterator.html#a2978026bd938a7badfc0429d98f69189',1,'IdxRangeSliceIterator']]], ['operator_2b_2b_1496',['operator++',['../structIdxRangeSliceIterator.html#aad83e0db3e4dae980fe233be4d9cd05a',1,'IdxRangeSliceIterator::operator++()'],['../structIdxRangeSliceIterator.html#ae6a30746321bcc04eaa331f8466383e7',1,'IdxRangeSliceIterator::operator++(int)']]], ['operator_2b_3d_1497',['operator+=',['../structIdxRangeSliceIterator.html#a514bf6156b13f8c11c115c7ba569391b',1,'IdxRangeSliceIterator']]],