Skip to content

Commit

Permalink
Expected output
Browse files Browse the repository at this point in the history
  • Loading branch information
sjoelund authored and OpenModelica-Hudson committed Jan 4, 2018
1 parent 7b5879e commit d264941
Show file tree
Hide file tree
Showing 34 changed files with 435 additions and 435 deletions.
24 changes: 12 additions & 12 deletions flattening/libraries/3rdParty/Buildings/System2.mo
Expand Up @@ -6712,7 +6712,7 @@ end System2;
// input Real Tsat(quantity = "ThermodynamicTemperature", unit = "K", displayUnit = "degC", min = 0.0, start = 288.15, nominal = 300.0);
// output Real psat(quantity = "Pressure", unit = "Pa", displayUnit = "bar", min = 0.0, nominal = 100000.0);
// algorithm
// psat := 611.657 * exp(17.2799 + -4102.99 / (-35.719 + Tsat));
// psat := 611.657 * exp(17.2799 + (-4102.99) / (-35.719 + Tsat));
// end Buildings.Fluid.Interfaces.ConservationEquation$vol$dynBal.Medium.saturationPressureLiquid;
//
// function Buildings.Fluid.Interfaces.ConservationEquation$vol$dynBal.Medium.setState_pTX
Expand Down Expand Up @@ -6846,7 +6846,7 @@ end System2;
// protected Real p_steam_sat(quantity = "Pressure", unit = "Pa", displayUnit = "bar", min = 0.0, nominal = 100000.0);
// protected Real x_sat(quantity = "MassFraction", unit = "1", min = 0.0, max = 1.0);
// algorithm
// T := 273.15 + (h + -2501014.5 * X[1]) / (dryair.cp * (1.0 - X[1]) + steam.cp * X[1]);
// T := 273.15 + (h + (-2501014.5) * X[1]) / (dryair.cp * (1.0 - X[1]) + steam.cp * X[1]);
// p_steam_sat := Buildings.Fluid.MixingVolumes.MixingVolume$vol.Medium.saturationPressure(T);
// x_sat := steam.MM * p_steam_sat / ((p - p_steam_sat) * dryair.MM);
// end Buildings.Fluid.MixingVolumes.MixingVolume$vol.Medium.T_phX;
Expand Down Expand Up @@ -6876,7 +6876,7 @@ end System2;
// input Real Tsat(quantity = "ThermodynamicTemperature", unit = "K", displayUnit = "degC", min = 0.0, start = 288.15, nominal = 300.0);
// output Real psat(quantity = "Pressure", unit = "Pa", displayUnit = "bar", min = 0.0, nominal = 100000.0);
// algorithm
// psat := 611.657 * exp(17.2799 + -4102.99 / (-35.719 + Tsat));
// psat := 611.657 * exp(17.2799 + (-4102.99) / (-35.719 + Tsat));
// end Buildings.Fluid.MixingVolumes.MixingVolume$vol.Medium.saturationPressureLiquid;
//
// function Buildings.Fluid.MixingVolumes.MixingVolume$vol.Medium.setState_pTX
Expand Down Expand Up @@ -7303,7 +7303,7 @@ end System2;
// input Real Tsat(quantity = "ThermodynamicTemperature", unit = "K", displayUnit = "degC", min = 0.0, start = 288.15, nominal = 300.0);
// output Real psat(quantity = "Pressure", unit = "Pa", displayUnit = "bar", min = 0.0, nominal = 100000.0);
// algorithm
// psat := 611.657 * exp(17.2799 + -4102.99 / (-35.719 + Tsat));
// psat := 611.657 * exp(17.2799 + (-4102.99) / (-35.719 + Tsat));
// end Buildings.Media.GasesPTDecoupled.MoistAirUnsaturated.saturationPressureLiquid;
//
// function Buildings.Media.GasesPTDecoupled.MoistAirUnsaturated.setState_pTX
Expand Down Expand Up @@ -7439,7 +7439,7 @@ end System2;
// input Real Tsat(quantity = "ThermodynamicTemperature", unit = "K", displayUnit = "degC", min = 0.0, start = 288.15, nominal = 300.0);
// output Real psat(quantity = "Pressure", unit = "Pa", displayUnit = "bar", min = 0.0, nominal = 100000.0);
// algorithm
// psat := 611.657 * exp(17.2799 + -4102.99 / (-35.719 + Tsat));
// psat := 611.657 * exp(17.2799 + (-4102.99) / (-35.719 + Tsat));
// end Buildings.Media.PerfectGases.MoistAir.saturationPressureLiquid;
//
// function Buildings.Media.PerfectGases.MoistAir.setState_pTX
Expand Down Expand Up @@ -7575,8 +7575,8 @@ end System2;
// y_d := delta ^ n;
// yP_d := n * delta ^ (-1.0 + n);
// yPP_d := n * (-1.0 + n) * delta ^ (-2.0 + n);
// a1 := -0.125 * (yP_d / delta - yPP_d) / delta2;
// a3 := 0.5 * yPP_d + -6.0 * a1 * delta2;
// a1 := (-0.125) * (yP_d / delta - yPP_d) / delta2;
// a3 := 0.5 * yPP_d + (-6.0) * a1 * delta2;
// a5 := y_d - delta2 * (a3 + delta2 * a1);
// y := a5 + x2 * (a3 + x2 * a1);
// assert(a5 > 0.0, "Delta is too small for this exponent.");
Expand Down Expand Up @@ -7740,7 +7740,7 @@ end System2;
// r[i] := -cr[i];
// end for;
// for i in 1:size(c0_in, 1) loop
// a[i] := -0.5 * c1[i];
// a[i] := (-0.5) * c1[i];
// b[i] := sqrt(c0[i] - a[i] ^ 2.0);
// ku[i] := c0[i] / b[i];
// end for;
Expand Down Expand Up @@ -8062,9 +8062,9 @@ end System2;
// t := (x - x1) / h;
// aux3 := t ^ 3.0;
// aux2 := t ^ 2.0;
// h00 := 1.0 + 2.0 * aux3 + -3.0 * aux2;
// h10 := aux3 + -2.0 * aux2 + t;
// h01 := 3.0 * aux2 + -2.0 * aux3;
// h00 := 1.0 + 2.0 * aux3 + (-3.0) * aux2;
// h10 := aux3 + (-2.0) * aux2 + t;
// h01 := 3.0 * aux2 + (-2.0) * aux3;
// h11 := aux3 - aux2;
// y := y1 * h00 + h * y1d * h10 + y2 * h01 + h * y2d * h11;
// else
Expand Down Expand Up @@ -10016,7 +10016,7 @@ end System2;
// pumRad.WFlo = pumRad.dpMachine * pumRad.VMachine_flow;
// pumRad.etaHyd * pumRad.WHyd = pumRad.WFlo;
// pumRad.QThe_flow + pumRad.WFlo = if pumRad.motorCooledByFluid then pumRad.P else pumRad.WHyd;
// pumRad.Q_flow = homotopy(Buildings.Utilities.Math.Functions.spliceFunction(pumRad.QThe_flow, 0.0, abs(pumRad.VMachine_flow) + -2.0 * pumRad.delta_V_flow, pumRad.delta_V_flow), 0.0);
// pumRad.Q_flow = homotopy(Buildings.Utilities.Math.Functions.spliceFunction(pumRad.QThe_flow, 0.0, abs(pumRad.VMachine_flow) + (-2.0) * pumRad.delta_V_flow, pumRad.delta_V_flow), 0.0);
// assert(sou.medium.T >= 272.15 and sou.medium.T <= 403.15, "
// Temperature T (= " + String(sou.medium.T, 0, true, 6) + " K) is not
// in the allowed range (" + String(272.15, 0, true, 6) + " K <= T <= " + String(403.15, 0, true, 6) + " K)
Expand Down
6 changes: 3 additions & 3 deletions flattening/libraries/biochem/BiochemModels.mos
Expand Up @@ -1091,7 +1091,7 @@ checkModel(BioChem.Examples.MultiCompartments.Utilities.SmallCompartment); getEr
// cytosol.F6P.c = cytosol.F6P.n1.c;
// cytosol.V = cytosol.F6P.n1.V;
// cytosol.F6P.c = cytosol.F6P.n / cytosol.V;
// cytosol.jda.rr = cytosol.jda.KcatDA * cytosol.jda.s1.c / (cytosol.jda.KmAMP + cytosol.jda.s1.c) + -0.01 * cytosol.jda.p1.c / (cytosol.jda.KmIMP + cytosol.jda.p1.c);
// cytosol.jda.rr = cytosol.jda.KcatDA * cytosol.jda.s1.c / (cytosol.jda.KmAMP + cytosol.jda.s1.c) + (-0.01) * cytosol.jda.p1.c / (cytosol.jda.KmIMP + cytosol.jda.p1.c);
// cytosol.jda.s1.r = cytosol.jda.nS1 * cytosol.jda.rr;
// cytosol.jda.p1.r = (-cytosol.jda.nP1) * cytosol.jda.rr;
// cytosol.vpfk.rr = cytosol.vpfk.KcatPFK * cytosol.vpfk.s1.c ^ cytosol.vpfk.n_sbml / (cytosol.vpfk.KmF6P + cytosol.vpfk.s1.c ^ cytosol.vpfk.n_sbml);
Expand Down Expand Up @@ -1121,7 +1121,7 @@ checkModel(BioChem.Examples.MultiCompartments.Utilities.SmallCompartment); getEr
// cytosol.jatpase.rr = cytosol.jatpase.KcatATPase * cytosol.jatpase.s1.c / (0.05 + cytosol.jatpase.s1.c);
// cytosol.jatpase.s1.r = cytosol.jatpase.nS1 * cytosol.jatpase.rr;
// cytosol.jatpase.p1.r = (-cytosol.jatpase.nP1) * cytosol.jatpase.rr;
// cytosol.jck.rr = cytosol.jck.KcatCK * (1.84331797235023 * cytosol.jck.s1.c * cytosol.jck.s2.c + -293.33 * cytosol.jck.p1.c * cytosol.jck.p2.c) / (1.0 + 0.02865329512893983 * cytosol.jck.s2.c + 1.25 * cytosol.jck.p2.c + cytosol.jck.s1.c * (1.43 + 0.09216589861751152 * cytosol.jck.s2.c) + cytosol.jck.p1.c * (16.7 + 10.0 * cytosol.jck.p2.c + 0.4761904761904762 * cytosol.jck.s2.c));
// cytosol.jck.rr = cytosol.jck.KcatCK * (1.84331797235023 * cytosol.jck.s1.c * cytosol.jck.s2.c + (-293.33) * cytosol.jck.p1.c * cytosol.jck.p2.c) / (1.0 + 0.02865329512893983 * cytosol.jck.s2.c + 1.25 * cytosol.jck.p2.c + cytosol.jck.s1.c * (1.43 + 0.09216589861751152 * cytosol.jck.s2.c) + cytosol.jck.p1.c * (16.7 + 10.0 * cytosol.jck.p2.c + 0.4761904761904762 * cytosol.jck.s2.c));
// cytosol.jck.s1.r = cytosol.jck.nS1 * cytosol.jck.rr;
// cytosol.jck.s2.r = cytosol.jck.nS2 * cytosol.jck.rr;
// cytosol.jck.p1.r = (-cytosol.jck.nP1) * cytosol.jck.rr;
Expand Down Expand Up @@ -1182,7 +1182,7 @@ checkModel(BioChem.Examples.MultiCompartments.Utilities.SmallCompartment); getEr
// atpt = tan + (-cytosol.IMP.c) - adpt - ampt;
// ampt = cytosol.AMP.c * bamp;
// atp = atpt / cytosol.V;
// pn = (PNt + -3.0 * atpt + -2.0 * adpt + -2.0 * cytosol.CP.c + (-2.0 * cytosol.FDP.c + (-cytosol.DHAP.c) - cytosol.G3P.c - cytosol.G6P.c - cytosol.F6P.c) * cytosol.V + (-cytosol.IMP.c) - ampt) / cytosol.V;
// pn = (PNt + (-3.0) * atpt + (-2.0) * adpt + (-2.0) * cytosol.CP.c + ((-2.0) * cytosol.FDP.c + (-cytosol.DHAP.c) - cytosol.G3P.c - cytosol.G6P.c - cytosol.F6P.c) * cytosol.V + (-cytosol.IMP.c) - ampt) / cytosol.V;
// bamp = k2amp * kamp / (kamp + cytosol.AMP.c);
// nad = 0.7 - cytosol.NADH.c;
// cr = tcr - cytosol.CP.c;
Expand Down
Expand Up @@ -178,7 +178,7 @@ end FunctionSimplex;
// for j in 1:N loop
// for k in 1:M loop
// if j <> p and k <> q then
// a[j,k] := a[j,k] + -0.3 * /*Real*/(j);
// a[j,k] := a[j,k] + (-0.3) * /*Real*/(j);
// end if;
// end for;
// end for;
Expand Down
6 changes: 3 additions & 3 deletions flattening/modelica/algorithms-functions/SumSeriesWhile.mo
Expand Up @@ -21,17 +21,17 @@ end SumSeries;

// Result:
// class SumSeries
// parameter Real eps = 0.000001;
// parameter Real eps = 1e-06;
// Integer i;
// Real sum;
// Real delta;
// algorithm
// i := 1;
// delta := exp(-0.01 * /*Real*/(i));
// delta := exp((-0.01) * /*Real*/(i));
// while delta >= eps loop
// sum := sum + delta;
// i := 1 + i;
// delta := exp(-0.01 * /*Real*/(i));
// delta := exp((-0.01) * /*Real*/(i));
// end while;
// end SumSeries;
// endResult
12 changes: 6 additions & 6 deletions flattening/modelica/arrays/FillSubscriptsTest.mo
Expand Up @@ -3858,7 +3858,7 @@ end Manifold;
// output Real dp(quantity = "Pressure", unit = "Pa", displayUnit = "Pa");
// protected Real kSquInv(unit = "1/(kg.m)");
// algorithm
// kSquInv := k ^ -2.0;
// kSquInv := k ^ (-2.0);
// dp := Modelica.Fluid.Utilities.regSquare2(m_flow, m_flow_turbulent, kSquInv, kSquInv, false, 1.0);
// end Buildings.Fluid.BaseClasses.FlowModels.basicFlowFunction_m_flow;
//
Expand Down Expand Up @@ -4117,7 +4117,7 @@ end Manifold;
// input Real Tsat(quantity = "ThermodynamicTemperature", unit = "K", displayUnit = "degC", min = 0.0, start = 288.15, nominal = 300.0);
// output Real psat(quantity = "Pressure", unit = "Pa", displayUnit = "bar", min = 0.0, nominal = 100000.0);
// algorithm
// psat := 611.657 * exp(17.2799 + -4102.99 / (-35.719 + Tsat));
// psat := 611.657 * exp(17.2799 + (-4102.99) / (-35.719 + Tsat));
// end Buildings.Fluid.Sources.Boundary_pT$sin_2.Medium.saturationPressureLiquid;
//
// function Buildings.Fluid.Sources.Boundary_pT$sin_2.Medium.setState_pTX
Expand Down Expand Up @@ -4244,7 +4244,7 @@ end Manifold;
// input Real Tsat(quantity = "ThermodynamicTemperature", unit = "K", displayUnit = "degC", min = 0.0, start = 288.15, nominal = 300.0);
// output Real psat(quantity = "Pressure", unit = "Pa", displayUnit = "bar", min = 0.0, nominal = 100000.0);
// algorithm
// psat := 611.657 * exp(17.2799 + -4102.99 / (-35.719 + Tsat));
// psat := 611.657 * exp(17.2799 + (-4102.99) / (-35.719 + Tsat));
// end Buildings.Fluid.Sources.Boundary_pT$sou_2.Medium.saturationPressureLiquid;
//
// function Buildings.Fluid.Sources.Boundary_pT$sou_2.Medium.setState_pTX
Expand Down Expand Up @@ -5026,7 +5026,7 @@ end Manifold;
// protected Real xx;
// algorithm
// a1 := x1 * y0d;
// a2 := 3.0 * y1 + -2.0 * a1 - x1 * y1d;
// a2 := 3.0 * y1 + (-2.0) * a1 - x1 * y1d;
// a3 := y1 + (-a2) - a1;
// xx := x / x1;
// y := xx * (a1 + xx * (a2 + xx * a3));
Expand Down Expand Up @@ -5070,12 +5070,12 @@ end Manifold;
// y1 := k1 * x1 ^ 2.0;
// y2 := (-k2) * x2 ^ 2.0;
// y1d := 2.0 * k1 * x1;
// y2d := -2.0 * k2 * x2;
// y2d := (-2.0) * k2 * x2;
// if use_yd0 then
// y0d := yd0;
// else
// w := x2 / x1;
// y0d := 0.5 * ((3.0 * y2 - x2 * y2d) / w + (x1 * y1d + -3.0 * y1) * w) / ((1.0 - w) * x1);
// y0d := 0.5 * ((3.0 * y2 - x2 * y2d) / w + (x1 * y1d + (-3.0) * y1) * w) / ((1.0 - w) * x1);
// end if;
// w1 := 2.23606797749979 * k1 * x1;
// w2 := 2.23606797749979 * k2 * abs(x2);
Expand Down
2 changes: 1 addition & 1 deletion flattening/modelica/equations/DAEexample.mo
Expand Up @@ -21,6 +21,6 @@ end DAEexample;
// parameter Real a = 2.0;
// equation
// (1.0 + 0.5 * sin(y)) * der(x) + der(y) = a * sin(time);
// x - y = exp(-0.9 * x) * cos(y);
// x - y = exp((-0.9) * x) * cos(y);
// end DAEexample;
// endResult
58 changes: 29 additions & 29 deletions flattening/modelica/equations/WaveEquationSample.mo
Expand Up @@ -111,7 +111,7 @@ end WaveEquationSample;
// Real dp[29](start = 0.0);
// Real dp[30](start = 0.0);
// equation
// p[1] = exp(-(-0.5 * L) ^ 2.0);
// p[1] = exp(-((-0.5) * L) ^ 2.0);
// p[30] = exp(-(0.5 * L) ^ 2.0);
// dp[1] = der(p[1]);
// dp[2] = der(p[2]);
Expand Down Expand Up @@ -143,33 +143,33 @@ end WaveEquationSample;
// dp[28] = der(p[28]);
// dp[29] = der(p[29]);
// dp[30] = der(p[30]);
// der(dp[2]) = c ^ 2.0 * (p[3] + -2.0 * p[2] + p[1]) / dL ^ 2.0;
// der(dp[3]) = c ^ 2.0 * (p[4] + -2.0 * p[3] + p[2]) / dL ^ 2.0;
// der(dp[4]) = c ^ 2.0 * (p[5] + -2.0 * p[4] + p[3]) / dL ^ 2.0;
// der(dp[5]) = c ^ 2.0 * (p[6] + -2.0 * p[5] + p[4]) / dL ^ 2.0;
// der(dp[6]) = c ^ 2.0 * (p[7] + -2.0 * p[6] + p[5]) / dL ^ 2.0;
// der(dp[7]) = c ^ 2.0 * (p[8] + -2.0 * p[7] + p[6]) / dL ^ 2.0;
// der(dp[8]) = c ^ 2.0 * (p[9] + -2.0 * p[8] + p[7]) / dL ^ 2.0;
// der(dp[9]) = c ^ 2.0 * (p[10] + -2.0 * p[9] + p[8]) / dL ^ 2.0;
// der(dp[10]) = c ^ 2.0 * (p[11] + -2.0 * p[10] + p[9]) / dL ^ 2.0;
// der(dp[11]) = c ^ 2.0 * (p[12] + -2.0 * p[11] + p[10]) / dL ^ 2.0;
// der(dp[12]) = c ^ 2.0 * (p[13] + -2.0 * p[12] + p[11]) / dL ^ 2.0;
// der(dp[13]) = c ^ 2.0 * (p[14] + -2.0 * p[13] + p[12]) / dL ^ 2.0;
// der(dp[14]) = c ^ 2.0 * (p[15] + -2.0 * p[14] + p[13]) / dL ^ 2.0;
// der(dp[15]) = c ^ 2.0 * (p[16] + -2.0 * p[15] + p[14]) / dL ^ 2.0;
// der(dp[16]) = c ^ 2.0 * (p[17] + -2.0 * p[16] + p[15]) / dL ^ 2.0;
// der(dp[17]) = c ^ 2.0 * (p[18] + -2.0 * p[17] + p[16]) / dL ^ 2.0;
// der(dp[18]) = c ^ 2.0 * (p[19] + -2.0 * p[18] + p[17]) / dL ^ 2.0;
// der(dp[19]) = c ^ 2.0 * (p[20] + -2.0 * p[19] + p[18]) / dL ^ 2.0;
// der(dp[20]) = c ^ 2.0 * (p[21] + -2.0 * p[20] + p[19]) / dL ^ 2.0;
// der(dp[21]) = c ^ 2.0 * (p[22] + -2.0 * p[21] + p[20]) / dL ^ 2.0;
// der(dp[22]) = c ^ 2.0 * (p[23] + -2.0 * p[22] + p[21]) / dL ^ 2.0;
// der(dp[23]) = c ^ 2.0 * (p[24] + -2.0 * p[23] + p[22]) / dL ^ 2.0;
// der(dp[24]) = c ^ 2.0 * (p[25] + -2.0 * p[24] + p[23]) / dL ^ 2.0;
// der(dp[25]) = c ^ 2.0 * (p[26] + -2.0 * p[25] + p[24]) / dL ^ 2.0;
// der(dp[26]) = c ^ 2.0 * (p[27] + -2.0 * p[26] + p[25]) / dL ^ 2.0;
// der(dp[27]) = c ^ 2.0 * (p[28] + -2.0 * p[27] + p[26]) / dL ^ 2.0;
// der(dp[28]) = c ^ 2.0 * (p[29] + -2.0 * p[28] + p[27]) / dL ^ 2.0;
// der(dp[29]) = c ^ 2.0 * (p[30] + -2.0 * p[29] + p[28]) / dL ^ 2.0;
// der(dp[2]) = c ^ 2.0 * (p[3] + (-2.0) * p[2] + p[1]) / dL ^ 2.0;
// der(dp[3]) = c ^ 2.0 * (p[4] + (-2.0) * p[3] + p[2]) / dL ^ 2.0;
// der(dp[4]) = c ^ 2.0 * (p[5] + (-2.0) * p[4] + p[3]) / dL ^ 2.0;
// der(dp[5]) = c ^ 2.0 * (p[6] + (-2.0) * p[5] + p[4]) / dL ^ 2.0;
// der(dp[6]) = c ^ 2.0 * (p[7] + (-2.0) * p[6] + p[5]) / dL ^ 2.0;
// der(dp[7]) = c ^ 2.0 * (p[8] + (-2.0) * p[7] + p[6]) / dL ^ 2.0;
// der(dp[8]) = c ^ 2.0 * (p[9] + (-2.0) * p[8] + p[7]) / dL ^ 2.0;
// der(dp[9]) = c ^ 2.0 * (p[10] + (-2.0) * p[9] + p[8]) / dL ^ 2.0;
// der(dp[10]) = c ^ 2.0 * (p[11] + (-2.0) * p[10] + p[9]) / dL ^ 2.0;
// der(dp[11]) = c ^ 2.0 * (p[12] + (-2.0) * p[11] + p[10]) / dL ^ 2.0;
// der(dp[12]) = c ^ 2.0 * (p[13] + (-2.0) * p[12] + p[11]) / dL ^ 2.0;
// der(dp[13]) = c ^ 2.0 * (p[14] + (-2.0) * p[13] + p[12]) / dL ^ 2.0;
// der(dp[14]) = c ^ 2.0 * (p[15] + (-2.0) * p[14] + p[13]) / dL ^ 2.0;
// der(dp[15]) = c ^ 2.0 * (p[16] + (-2.0) * p[15] + p[14]) / dL ^ 2.0;
// der(dp[16]) = c ^ 2.0 * (p[17] + (-2.0) * p[16] + p[15]) / dL ^ 2.0;
// der(dp[17]) = c ^ 2.0 * (p[18] + (-2.0) * p[17] + p[16]) / dL ^ 2.0;
// der(dp[18]) = c ^ 2.0 * (p[19] + (-2.0) * p[18] + p[17]) / dL ^ 2.0;
// der(dp[19]) = c ^ 2.0 * (p[20] + (-2.0) * p[19] + p[18]) / dL ^ 2.0;
// der(dp[20]) = c ^ 2.0 * (p[21] + (-2.0) * p[20] + p[19]) / dL ^ 2.0;
// der(dp[21]) = c ^ 2.0 * (p[22] + (-2.0) * p[21] + p[20]) / dL ^ 2.0;
// der(dp[22]) = c ^ 2.0 * (p[23] + (-2.0) * p[22] + p[21]) / dL ^ 2.0;
// der(dp[23]) = c ^ 2.0 * (p[24] + (-2.0) * p[23] + p[22]) / dL ^ 2.0;
// der(dp[24]) = c ^ 2.0 * (p[25] + (-2.0) * p[24] + p[23]) / dL ^ 2.0;
// der(dp[25]) = c ^ 2.0 * (p[26] + (-2.0) * p[25] + p[24]) / dL ^ 2.0;
// der(dp[26]) = c ^ 2.0 * (p[27] + (-2.0) * p[26] + p[25]) / dL ^ 2.0;
// der(dp[27]) = c ^ 2.0 * (p[28] + (-2.0) * p[27] + p[26]) / dL ^ 2.0;
// der(dp[28]) = c ^ 2.0 * (p[29] + (-2.0) * p[28] + p[27]) / dL ^ 2.0;
// der(dp[29]) = c ^ 2.0 * (p[30] + (-2.0) * p[29] + p[28]) / dL ^ 2.0;
// end WaveEquationSample;
// endResult

0 comments on commit d264941

Please sign in to comment.