From 7f162008a2eea123a43f241e5e214dadf6b9e88e Mon Sep 17 00:00:00 2001
From: Luc Maisonobe
+ * This method is described in H. A. Luther 1968 paper
+ * An explicit Sixth-Order Runge-Kutta Formula.
+ * This method is an explicit Runge-Kutta method, its Butcher-array
+ * is the following one :
+ *
+ * 0 | 0 0 0 0 0 0
+ * 1 | 1 0 0 0 0 0
+ * 1/2 | 3/8 1/8 0 0 0 0
+ * 2/3 | 8/27 2/27 8/27 0 0 0
+ * (7-q)/14 | ( -21 + 9q)/392 ( -56 + 8q)/392 ( 336 - 48q)/392 ( -63 + 3q)/392 0 0
+ * (7+q)/14 | (-1155 - 255q)/1960 ( -280 - 40q)/1960 ( 0 - 320q)/1960 ( 63 + 363q)/1960 ( 2352 + 392q)/1960 0
+ * 1 | ( 330 + 105q)/180 ( 120 + 0q)/180 ( -200 + 280q)/180 ( 126 - 189q)/180 ( -686 - 126q)/180 ( 490 - 70q)/180
+ * |--------------------------------------------------------------------------------------------------------------------------------------------------
+ * | 1/20 0 16/45 0 49/180 49/180 1/20
+ *
+ * where q = √21
This interpolator computes dense output inside the last + * step computed. The interpolation equation is consistent with the + * integration scheme.
+ * + * @see LutherIntegrator + * @version $Id$ + * @since 3.3 + */ + +class LutherStepInterpolator extends RungeKuttaStepInterpolator { + + /** Serializable version identifier */ + private static final long serialVersionUID = 20140416L; + + /** Square root. */ + private static final double Q = FastMath.sqrt(21); + + /** Simple constructor. + * This constructor builds an instance that is not usable yet, the + * {@link + * org.apache.commons.math3.ode.sampling.AbstractStepInterpolator#reinitialize} + * method should be called before using the instance in order to + * initialize the internal arrays. This constructor is used only + * in order to delay the initialization in some cases. The {@link + * RungeKuttaIntegrator} class uses the prototyping design pattern + * to create the step interpolators by cloning an uninitialized model + * and later initializing the copy. + */ + public LutherStepInterpolator() { + } + + /** Copy constructor. + * @param interpolator interpolator to copy from. The copy is a deep + * copy: its arrays are separated from the original arrays of the + * instance + */ + public LutherStepInterpolator(final LutherStepInterpolator interpolator) { + super(interpolator); + } + + /** {@inheritDoc} */ + @Override + protected StepInterpolator doCopy() { + return new LutherStepInterpolator(this); + } + + + /** {@inheritDoc} */ + @Override + protected void computeInterpolatedStateAndDerivatives(final double theta, + final double oneMinusThetaH) { + + // the coefficients below have been computed by solving the + // order conditions from a theorem from Butcher (1963), using + // the method explained in Folkmar Bornemann paper "Runge-Kutta + // Methods, Trees, and Maple", Center of Mathematical Sciences, Munich + // University of Technology, February 9, 2001 + //diff --git a/src/test/java/org/apache/commons/math3/ode/nonstiff/LutherIntegratorTest.java b/src/test/java/org/apache/commons/math3/ode/nonstiff/LutherIntegratorTest.java new file mode 100644 index 000000000..fb8cbcaa3 --- /dev/null +++ b/src/test/java/org/apache/commons/math3/ode/nonstiff/LutherIntegratorTest.java @@ -0,0 +1,309 @@ +/* + * Licensed to the Apache Software Foundation (ASF) under one or more + * contributor license agreements. See the NOTICE file distributed with + * this work for additional information regarding copyright ownership. + * The ASF licenses this file to You under the Apache License, Version 2.0 + * (the "License"); you may not use this file except in compliance with + * the License. You may obtain a copy of the License at + * + * http://www.apache.org/licenses/LICENSE-2.0 + * + * Unless required by applicable law or agreed to in writing, software + * distributed under the License is distributed on an "AS IS" BASIS, + * WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. + * See the License for the specific language governing permissions and + * limitations under the License. + */ + +package org.apache.commons.math3.ode.nonstiff; + + +import org.apache.commons.math3.exception.DimensionMismatchException; +import org.apache.commons.math3.exception.MaxCountExceededException; +import org.apache.commons.math3.exception.NoBracketingException; +import org.apache.commons.math3.exception.NumberIsTooSmallException; +import org.apache.commons.math3.ode.FirstOrderDifferentialEquations; +import org.apache.commons.math3.ode.FirstOrderIntegrator; +import org.apache.commons.math3.ode.TestProblem1; +import org.apache.commons.math3.ode.TestProblem3; +import org.apache.commons.math3.ode.TestProblem5; +import org.apache.commons.math3.ode.TestProblemAbstract; +import org.apache.commons.math3.ode.TestProblemFactory; +import org.apache.commons.math3.ode.TestProblemHandler; +import org.apache.commons.math3.ode.events.EventHandler; +import org.apache.commons.math3.ode.sampling.StepHandler; +import org.apache.commons.math3.ode.sampling.StepInterpolator; +import org.apache.commons.math3.util.FastMath; +import org.junit.Assert; +import org.junit.Test; + +public class LutherIntegratorTest { + + @Test + public void testMissedEndEvent() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + final double t0 = 1878250320.0000029; + final double tEvent = 1878250379.9999986; + final double[] k = { 1.0e-4, 1.0e-5, 1.0e-6 }; + FirstOrderDifferentialEquations ode = new FirstOrderDifferentialEquations() { + + public int getDimension() { + return k.length; + } + + public void computeDerivatives(double t, double[] y, double[] yDot) { + for (int i = 0; i < y.length; ++i) { + yDot[i] = k[i] * y[i]; + } + } + }; + + LutherIntegrator integrator = new LutherIntegrator(60.0); + + double[] y0 = new double[k.length]; + for (int i = 0; i < y0.length; ++i) { + y0[i] = i + 1; + } + double[] y = new double[k.length]; + + double finalT = integrator.integrate(ode, t0, y0, tEvent, y); + Assert.assertEquals(tEvent, finalT, 1.0e-15); + for (int i = 0; i < y.length; ++i) { + Assert.assertEquals(y0[i] * FastMath.exp(k[i] * (finalT - t0)), y[i], 1.0e-15); + } + + integrator.addEventHandler(new EventHandler() { + + public void init(double t0, double[] y0, double t) { + } + + public void resetState(double t, double[] y) { + } + + public double g(double t, double[] y) { + return t - tEvent; + } + + public Action eventOccurred(double t, double[] y, boolean increasing) { + Assert.assertEquals(tEvent, t, 1.0e-15); + return Action.CONTINUE; + } + }, Double.POSITIVE_INFINITY, 1.0e-20, 100); + finalT = integrator.integrate(ode, t0, y0, tEvent + 120, y); + Assert.assertEquals(tEvent + 120, finalT, 1.0e-15); + for (int i = 0; i < y.length; ++i) { + Assert.assertEquals(y0[i] * FastMath.exp(k[i] * (finalT - t0)), y[i], 1.0e-15); + } + + } + + @Test + public void testSanityChecks() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + try { + TestProblem1 pb = new TestProblem1(); + new LutherIntegrator(0.01).integrate(pb, + 0.0, new double[pb.getDimension()+10], + 1.0, new double[pb.getDimension()]); + Assert.fail("an exception should have been thrown"); + } catch(DimensionMismatchException ie) { + } + try { + TestProblem1 pb = new TestProblem1(); + new LutherIntegrator(0.01).integrate(pb, + 0.0, new double[pb.getDimension()], + 1.0, new double[pb.getDimension()+10]); + Assert.fail("an exception should have been thrown"); + } catch(DimensionMismatchException ie) { + } + try { + TestProblem1 pb = new TestProblem1(); + new LutherIntegrator(0.01).integrate(pb, + 0.0, new double[pb.getDimension()], + 0.0, new double[pb.getDimension()]); + Assert.fail("an exception should have been thrown"); + } catch(NumberIsTooSmallException ie) { + } + } + + @Test + public void testDecreasingSteps() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + + TestProblemAbstract[] problems = TestProblemFactory.getProblems(); + for (int k = 0; k < problems.length; ++k) { + + double previousValueError = Double.NaN; + double previousTimeError = Double.NaN; + for (int i = 4; i < 10; ++i) { + + TestProblemAbstract pb = problems[k].copy(); + double step = (pb.getFinalTime() - pb.getInitialTime()) * FastMath.pow(2.0, -i); + + FirstOrderIntegrator integ = new LutherIntegrator(step); + TestProblemHandler handler = new TestProblemHandler(pb, integ); + integ.addStepHandler(handler); + EventHandler[] functions = pb.getEventsHandlers(); + for (int l = 0; l < functions.length; ++l) { + integ.addEventHandler(functions[l], + Double.POSITIVE_INFINITY, 1.0e-6 * step, 1000); + } + Assert.assertEquals(functions.length, integ.getEventHandlers().size()); + double stopTime = integ.integrate(pb, pb.getInitialTime(), pb.getInitialState(), + pb.getFinalTime(), new double[pb.getDimension()]); + if (functions.length == 0) { + Assert.assertEquals(pb.getFinalTime(), stopTime, 1.0e-10); + } + + double error = handler.getMaximalValueError(); + if (i > 4) { + Assert.assertTrue(error < 1.01 * FastMath.abs(previousValueError)); + } + previousValueError = error; + + double timeError = handler.getMaximalTimeError(); + if (i > 4) { + Assert.assertTrue(timeError <= FastMath.abs(previousTimeError)); + } + previousTimeError = timeError; + + integ.clearEventHandlers(); + Assert.assertEquals(0, integ.getEventHandlers().size()); + } + + } + + } + + @Test + public void testSmallStep() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + + TestProblem1 pb = new TestProblem1(); + double step = (pb.getFinalTime() - pb.getInitialTime()) * 0.001; + + FirstOrderIntegrator integ = new LutherIntegrator(step); + TestProblemHandler handler = new TestProblemHandler(pb, integ); + integ.addStepHandler(handler); + integ.integrate(pb, pb.getInitialTime(), pb.getInitialState(), + pb.getFinalTime(), new double[pb.getDimension()]); + + Assert.assertTrue(handler.getLastError() < 9.0e-17); + Assert.assertTrue(handler.getMaximalValueError() < 4.0e-15); + Assert.assertEquals(0, handler.getMaximalTimeError(), 1.0e-12); + Assert.assertEquals("Luther", integ.getName()); + } + + @Test + public void testBigStep() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + + TestProblem1 pb = new TestProblem1(); + double step = (pb.getFinalTime() - pb.getInitialTime()) * 0.2; + + FirstOrderIntegrator integ = new LutherIntegrator(step); + TestProblemHandler handler = new TestProblemHandler(pb, integ); + integ.addStepHandler(handler); + integ.integrate(pb, pb.getInitialTime(), pb.getInitialState(), + pb.getFinalTime(), new double[pb.getDimension()]); + + Assert.assertTrue(handler.getLastError() > 0.00002); + Assert.assertTrue(handler.getMaximalValueError() > 0.001); + Assert.assertEquals(0, handler.getMaximalTimeError(), 1.0e-12); + + } + + @Test + public void testBackward() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + + TestProblem5 pb = new TestProblem5(); + double step = FastMath.abs(pb.getFinalTime() - pb.getInitialTime()) * 0.001; + + FirstOrderIntegrator integ = new LutherIntegrator(step); + TestProblemHandler handler = new TestProblemHandler(pb, integ); + integ.addStepHandler(handler); + integ.integrate(pb, pb.getInitialTime(), pb.getInitialState(), + pb.getFinalTime(), new double[pb.getDimension()]); + + Assert.assertTrue(handler.getLastError() < 3.0e-13); + Assert.assertTrue(handler.getMaximalValueError() < 5.0e-13); + Assert.assertEquals(0, handler.getMaximalTimeError(), 1.0e-12); + Assert.assertEquals("Luther", integ.getName()); + } + + @Test + public void testKepler() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + + final TestProblem3 pb = new TestProblem3(0.9); + double step = (pb.getFinalTime() - pb.getInitialTime()) * 0.0003; + + FirstOrderIntegrator integ = new LutherIntegrator(step); + integ.addStepHandler(new KeplerHandler(pb)); + integ.integrate(pb, + pb.getInitialTime(), pb.getInitialState(), + pb.getFinalTime(), new double[pb.getDimension()]); + } + + private static class KeplerHandler implements StepHandler { + public KeplerHandler(TestProblem3 pb) { + this.pb = pb; + maxError = 0; + } + public void init(double t0, double[] y0, double t) { + maxError = 0; + } + public void handleStep(StepInterpolator interpolator, boolean isLast) { + + double[] interpolatedY = interpolator.getInterpolatedState (); + double[] theoreticalY = pb.computeTheoreticalState(interpolator.getCurrentTime()); + double dx = interpolatedY[0] - theoreticalY[0]; + double dy = interpolatedY[1] - theoreticalY[1]; + double error = dx * dx + dy * dy; + if (error > maxError) { + maxError = error; + } + if (isLast) { + Assert.assertTrue(maxError < 2.2e-7); + } + } + private double maxError = 0; + private TestProblem3 pb; + } + + @Test + public void testStepSize() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + final double step = 1.23456; + FirstOrderIntegrator integ = new LutherIntegrator(step); + integ.addStepHandler(new StepHandler() { + public void handleStep(StepInterpolator interpolator, boolean isLast) { + if (! isLast) { + Assert.assertEquals(step, + interpolator.getCurrentTime() - interpolator.getPreviousTime(), + 1.0e-12); + } + } + public void init(double t0, double[] y0, double t) { + } + }); + integ.integrate(new FirstOrderDifferentialEquations() { + public void computeDerivatives(double t, double[] y, double[] dot) { + dot[0] = 1.0; + } + public int getDimension() { + return 1; + } + }, 0.0, new double[] { 0.0 }, 5.0, new double[1]); + } + +} diff --git a/src/test/java/org/apache/commons/math3/ode/nonstiff/LutherStepInterpolatorTest.java b/src/test/java/org/apache/commons/math3/ode/nonstiff/LutherStepInterpolatorTest.java new file mode 100644 index 000000000..d29fe20c2 --- /dev/null +++ b/src/test/java/org/apache/commons/math3/ode/nonstiff/LutherStepInterpolatorTest.java @@ -0,0 +1,98 @@ +/* + * Licensed to the Apache Software Foundation (ASF) under one or more + * contributor license agreements. See the NOTICE file distributed with + * this work for additional information regarding copyright ownership. + * The ASF licenses this file to You under the Apache License, Version 2.0 + * (the "License"); you may not use this file except in compliance with + * the License. You may obtain a copy of the License at + * + * http://www.apache.org/licenses/LICENSE-2.0 + * + * Unless required by applicable law or agreed to in writing, software + * distributed under the License is distributed on an "AS IS" BASIS, + * WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. + * See the License for the specific language governing permissions and + * limitations under the License. + */ + +package org.apache.commons.math3.ode.nonstiff; + + +import java.io.ByteArrayInputStream; +import java.io.ByteArrayOutputStream; +import java.io.IOException; +import java.io.ObjectInputStream; +import java.io.ObjectOutputStream; +import java.util.Random; + +import org.apache.commons.math3.exception.DimensionMismatchException; +import org.apache.commons.math3.exception.MaxCountExceededException; +import org.apache.commons.math3.exception.NoBracketingException; +import org.apache.commons.math3.exception.NumberIsTooSmallException; +import org.apache.commons.math3.ode.ContinuousOutputModel; +import org.apache.commons.math3.ode.TestProblem3; +import org.apache.commons.math3.ode.sampling.StepHandler; +import org.apache.commons.math3.ode.sampling.StepInterpolatorTestUtils; +import org.junit.Assert; +import org.junit.Test; + +public class LutherStepInterpolatorTest { + + @Test + public void derivativesConsistency() + throws DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + TestProblem3 pb = new TestProblem3(); + double step = (pb.getFinalTime() - pb.getInitialTime()) * 0.001; + LutherIntegrator integ = new LutherIntegrator(step); + StepInterpolatorTestUtils.checkDerivativesConsistency(integ, pb, 1.0e-10); + } + + @Test + public void serialization() + throws IOException, ClassNotFoundException, + DimensionMismatchException, NumberIsTooSmallException, + MaxCountExceededException, NoBracketingException { + + TestProblem3 pb = new TestProblem3(0.9); + double step = (pb.getFinalTime() - pb.getInitialTime()) * 0.0003; + LutherIntegrator integ = new LutherIntegrator(step); + integ.addStepHandler(new ContinuousOutputModel()); + integ.integrate(pb, + pb.getInitialTime(), pb.getInitialState(), + pb.getFinalTime(), new double[pb.getDimension()]); + + ByteArrayOutputStream bos = new ByteArrayOutputStream(); + ObjectOutputStream oos = new ObjectOutputStream(bos); + for (StepHandler handler : integ.getStepHandlers()) { + oos.writeObject(handler); + } + + Assert.assertTrue(bos.size() > 1200000); + Assert.assertTrue(bos.size() < 1250000); + + ByteArrayInputStream bis = new ByteArrayInputStream(bos.toByteArray()); + ObjectInputStream ois = new ObjectInputStream(bis); + ContinuousOutputModel cm = (ContinuousOutputModel) ois.readObject(); + + Random random = new Random(347588535632l); + double maxError = 0.0; + for (int i = 0; i < 1000; ++i) { + double r = random.nextDouble(); + double time = r * pb.getInitialTime() + (1.0 - r) * pb.getFinalTime(); + cm.setInterpolatedTime(time); + double[] interpolatedY = cm.getInterpolatedState (); + double[] theoreticalY = pb.computeTheoreticalState(time); + double dx = interpolatedY[0] - theoreticalY[0]; + double dy = interpolatedY[1] - theoreticalY[1]; + double error = dx * dx + dy * dy; + if (error > maxError) { + maxError = error; + } + } + + Assert.assertTrue(maxError < 2.2e-7); + + } + +}