DEMO_febio_0045_tentacle_active_contraction_01.m

Contents

Keywords

clear; close all; clc;

Plot settings

figColor='w';
figColorDef='white';
fontSize=25;
markerSize1=25;
lineWidth1=3;
faceAlpha=0.5;
faceAlpha2=0.25;
vectorPlotSize=0.5;
markerSize=25;

Control parameters

% Path names
defaultFolder = fileparts(fileparts(mfilename('fullpath')));
savePath=fullfile(defaultFolder,'data','temp');

% Defining file names
febioFebFileNamePart='tempModel';
febioFebFileName=fullfile(savePath,[febioFebFileNamePart,'.feb']); %FEB file name
febioLogFileName=[febioFebFileNamePart,'.txt']; %FEBio log file name
febioLogFileName_disp=[febioFebFileNamePart,'_disp_out.txt']; %Log file name for exporting displacement

%Material parameter set
k_factor=10; %Bulk modulus factor
c1=1e-3; %Shear-modulus-like parameter
m1=2; %Material parameter setting degree of non-linearity of ground matrix
ksi=c1*1000;
k=c1*k_factor; %Bulk modulus
T0=5e-3; %Active stress

k_factor=100; %Bulk modulus factor
c1p=c1*10; %Shear-modulus-like parameter
m1p=m1; %Material parameter setting degree of non-linearity
kp=c1p*k_factor; %Bulk modulus

% FEA control settings
numTimeSteps=25; %Number of time steps desired
max_refs=40; %Max reforms
max_ups=0; %Set to zero to use full-Newton iterations
opt_iter=20; %Optimum number of iterations
max_retries=5; %Maximum number of retires
dtmin=(1/numTimeSteps)/100; %Minimum time step size
dtmax=(1/numTimeSteps); %Maximum time step size

tentacleHeight=70;

% Bar
barRadius=9;
barLocation=30;

%Contact parameters
contactPenalty=1;
laugon=0;
minaug=1;
maxaug=10;
fric_coeff=0.5;

Creating a loft feature

% Sketching profile 1
ns=15;
t=linspace(0,2*pi,ns);
t=t(1:end-1);
r1=5;
x=r1*cos(t);
y=r1*sin(t);
z=zeros(size(x));
V_bottom=[x(:) y(:) z(:)];
V_bottom(x>(r1/2))=(r1/2);
% V_bottom=evenlySampleCurve(V_bottom,ns,'pchip',1);
V_bottom(:,1)=V_bottom(:,1)-max(V_bottom(:,1));

% Sketching profile 2
t=linspace(0,2*pi,ns);
t=t(1:end-1);
r2=2;
x=r2*cos(t);
y=r2*sin(t);
z=zeros(size(x));
V_top=[x(:) y(:) z(:)];
V_top(x>(r2/2))=(r2/2);
V_top(:,3)=V_top(:,3)+tentacleHeight;
% V_top=evenlySampleCurve(V_top,ns,'pchip',1);
V_top(:,1)=V_top(:,1)-max(V_top(:,1));

% Create loft
% cPar.numSteps=17;
cPar.closeLoopOpt=1;
cPar.patchType='tri';
[F,V]=polyLoftLinear(V_bottom,V_top,cPar);

[Ft,Vt]=regionTriMesh2D({V_top(:,[1 2])},[],0,0);
Vt(:,3)=mean(V_top(:,3));

[Fb,Vb]=regionTriMesh2D({V_bottom(:,[1 2])},[],0,0);
Fb=fliplr(Fb);
Vb(:,3)=mean(V_bottom(:,3));

[F,V,C]=joinElementSets({F,Ft,Fb},{V,Vt,Vb});
[F,V]=mergeVertices(F,V);

indRigid=F(C==3,:);

cPar.Method='HC';
cPar.n=10;
cPar.RigidConstraints=unique(indRigid);
[V]=patchSmooth(F,V,[],cPar);

Plotting results

cFigure; hold on;
title('The lofted feature','FontSize',fontSize);

gpatch(F,V,C,'k',1);
% patchNormPlot(F,V);

colormap gjet; icolorbar;
axisGeom(gca,fontSize);
camlight headlight;
drawnow;

Tetrahedral meshing using tetgen (see also runTetGen)

% Create tetgen input structure
inputStruct.stringOpt='-pq1.2AaY';
inputStruct.Faces=F;
inputStruct.Nodes=V;
inputStruct.holePoints=[];
inputStruct.faceBoundaryMarker=C; %Face boundary markers
inputStruct.regionPoints=getInnerPoint(F,V); %region points
inputStruct.regionA=2*tetVolMeanEst(F,V);
inputStruct.minRegionMarker=2; %Minimum region marker

% Mesh model using tetrahedral elements using tetGen
[meshOutput]=runTetGen(inputStruct); %Run tetGen

% Access model element and patch data
Fb=meshOutput.facesBoundary;
Cb=meshOutput.boundaryMarker;
V=meshOutput.nodes;
CE=meshOutput.elementMaterialID;
E=meshOutput.elements;
 
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
--- TETGEN Tetrahedral meshing --- 18-Dec-2020 14:43:36
 
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
--- Writing SMESH file --- 18-Dec-2020 14:43:36
----> Adding node field
----> Adding facet field
----> Adding holes specification
----> Adding region specification
--- Done --- 18-Dec-2020 14:43:36
--- Running TetGen to mesh input boundary--- 18-Dec-2020 14:43:36
Opening /mnt/data/MATLAB/GIBBON/data/temp/temp.smesh.
Delaunizing vertices...
Delaunay seconds:  0.009008
Creating surface mesh ...
Surface mesh seconds:  0.001499
Recovering boundaries...
Boundary recovery seconds:  0.001894
Removing exterior tetrahedra ...
Spreading region attributes.
Exterior tets removal seconds:  0.000955
Recovering Delaunayness...
Delaunay recovery seconds:  0.000764
Refining mesh...
Refinement seconds:  0.01364
Optimizing mesh...
Optimization seconds:  0.001013

Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.node.
Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.ele.
Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.face.
Writing /mnt/data/MATLAB/GIBBON/data/temp/temp.1.edge.

Output seconds:  0.015188
Total running seconds:  0.044145

Statistics:

  Input points: 708
  Input facets: 1412
  Input segments: 2118
  Input holes: 0
  Input regions: 1

  Mesh points: 1137
  Mesh tetrahedra: 4592
  Mesh faces: 9890
  Mesh faces on exterior boundary: 1412
  Mesh faces on input facets: 1412
  Mesh edges on input segments: 2118
  Steiner points inside domain: 429

--- Done --- 18-Dec-2020 14:43:36
 
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
--- Importing TetGen files --- 18-Dec-2020 14:43:36
--- Done --- 18-Dec-2020 14:43:36

Visualizing mesh using meshView, see also anim8

meshView(meshOutput);

Split into two materials

[VE]=patchCentre(E,V); %Compute element centre coordinates

logicActive=VE(:,1)>=-r2;

E1=E( logicActive,:);
E2=E(~logicActive,:);
E=[E1; E2];
[VE1]=patchCentre(E1,V);

%Define fibers as going from one face center to the other
v_fib=[0 0 1];
e1_dir=v_fib(ones(size(E1,1),1),:);
[e2_dir,e3_dir]=vectorOrthogonalPair(e1_dir); %Get orthogonal vector pair

%Get boundary directions faces to set-up support
F_bottom=Fb(Cb==3,:); %The faces at the bottom
bcSupportList=unique(F_bottom(:)); %The node list for the bottom nodes

Visualize boundary conditions

cFigure; hold on;
gtitle('Boundary conditions and fiber directions',fontSize);
hl(1)=gpatch(Fb,V,'kw','none',0.25);
hl(2)=quiverVec(VE1,e1_dir,vectorPlotSize,'k');

hl(3)=gpatch(F_bottom,V,'rw','r',1);
hl(4)=plotV(V(bcSupportList,:),'r.','MarkerSize',markerSize);

legend(hl,{'Boundary faces','Fiber vectors','Bottom faces','Supported nodes'});

axisGeom(gca,fontSize);
camlight headlight;
drawnow;

clear hl;
w=4*r1; %Width measure

pointSpacing=mean(patchEdgeLengths(Fb,V));

optionStruct.cylRadius=barRadius;
optionStruct.numRadial=round((2*pi*barRadius)/(pointSpacing/2));
optionStruct.cylHeight=w/2;
% optionStruct.numHeight=optionStruct.numRadial;
optionStruct.meshType='tri';
optionStruct.closeOpt=0;
[Fc,Vc]=patchcylinder(optionStruct);
Fc=fliplr(Fc);

Vc=Vc(:,[1 3 2]);

% %Shift bar
Vc(:,1)=Vc(:,1)+barRadius+0.1*pointSpacing;
Vc(:,3)=Vc(:,3)+barLocation;

center_of_mass=mean(Vc,1);
cFigure; hold on;
gtitle('Boundary conditions and fiber directions',fontSize);
gpatch(Fb,V,'kw','none',0.25);

gpatch(Fc,Vc,'rw','k',1);
patchNormPlot(Fc,Vc);
axisGeom(gca,fontSize);
camlight headlight;
drawnow;

Joining node sets

Fc=Fc+size(V,1); %Fixed element indices
V=[V;Vc;]; %Combined node sets

Define contact surfaces

% The rigid primary surface of the sphere
F_contact_primary=Fc;

% The deformable secondary surface of the slab
F_contact_secondary=fliplr(Fb);

% Plotting surface models
cFigure; hold on;
title('Contact sets and normal directions','FontSize',fontSize);

gpatch(Fb,V,'kw','none',faceAlpha2);
hl(1)=gpatch(F_contact_primary,V,'gw','k',1);
patchNormPlot(F_contact_primary,V);
hl(2)=gpatch(F_contact_secondary,V,'bw','k',1);
patchNormPlot(F_contact_secondary,V);

legend(hl,{'primary','secondary'});

axisGeom(gca,fontSize);
camlight headlight;
drawnow;

Defining the FEBio input structure

See also febioStructTemplate and febioStruct2xml and the FEBio user manual.

%Get a template with default settings
[febio_spec]=febioStructTemplate;

%febio_spec version
febio_spec.ATTR.version='3.0';

%Module section
febio_spec.Module.ATTR.type='solid';

%Control section
febio_spec.Control.analysis='STATIC';
febio_spec.Control.time_steps=numTimeSteps;
febio_spec.Control.step_size=1/numTimeSteps;
febio_spec.Control.solver.max_refs=max_refs;
febio_spec.Control.solver.max_ups=max_ups;
febio_spec.Control.time_stepper.dtmin=dtmin;
febio_spec.Control.time_stepper.dtmax=dtmax;
febio_spec.Control.time_stepper.max_retries=max_retries;
febio_spec.Control.time_stepper.opt_iter=opt_iter;

%Material section
materialName1='Material1';
febio_spec.Material.material{1}.ATTR.name=materialName1;
febio_spec.Material.material{1}.ATTR.type='solid mixture';
febio_spec.Material.material{1}.ATTR.id=1;

%The gound matrix
febio_spec.Material.material{1}.solid{1}.ATTR.type='Ogden unconstrained';
febio_spec.Material.material{1}.solid{1}.c1=c1;
febio_spec.Material.material{1}.solid{1}.m1=m1;
febio_spec.Material.material{1}.solid{1}.c2=c1;
febio_spec.Material.material{1}.solid{1}.m2=-m1;
febio_spec.Material.material{1}.solid{1}.cp=k;

%The active fiber component
febio_spec.Material.material{1}.solid{2}.ATTR.type='prescribed uniaxial active contraction';
febio_spec.Material.material{1}.solid{2}.T0.VAL=T0;
febio_spec.Material.material{1}.solid{2}.T0.ATTR.lc=1;

%The passive material
materialName2='Material2';
febio_spec.Material.material{2}.ATTR.name=materialName2;
febio_spec.Material.material{2}.ATTR.type='Ogden';
febio_spec.Material.material{2}.ATTR.id=2;
febio_spec.Material.material{2}.c1=c1p;
febio_spec.Material.material{2}.m1=m1p;
febio_spec.Material.material{2}.c2=c1p;
febio_spec.Material.material{2}.m2=-m1p;
febio_spec.Material.material{2}.k=kp;

materialName3='Material3';
febio_spec.Material.material{3}.ATTR.name=materialName3;
febio_spec.Material.material{3}.ATTR.type='rigid body';
febio_spec.Material.material{3}.ATTR.id=3;
febio_spec.Material.material{3}.density=1e-9;
febio_spec.Material.material{3}.center_of_mass=mean(Vc,1);

% Mesh section
% -> Nodes
febio_spec.Mesh.Nodes{1}.ATTR.name='Object1'; %The node set name
febio_spec.Mesh.Nodes{1}.node.ATTR.id=(1:size(V,1))'; %The node id's
febio_spec.Mesh.Nodes{1}.node.VAL=V; %The nodel coordinates

% -> Elements
partName1='Part1';
febio_spec.Mesh.Elements{1}.ATTR.name=partName1; %Name of this part
febio_spec.Mesh.Elements{1}.ATTR.type='tet4'; %Element type
febio_spec.Mesh.Elements{1}.elem.ATTR.id=(1:1:size(E1,1))'; %Element id's
febio_spec.Mesh.Elements{1}.elem.VAL=E1; %The element matrix

partName2='Part2';
febio_spec.Mesh.Elements{2}.ATTR.name=partName2; %Name of this part
febio_spec.Mesh.Elements{2}.ATTR.type='tet4'; %Element type
febio_spec.Mesh.Elements{2}.elem.ATTR.id=size(E1,1)+(1:1:size(E2,1))'; %Element id's
febio_spec.Mesh.Elements{2}.elem.VAL=E2; %The element matrix

partName3='Part3';
febio_spec.Mesh.Elements{3}.ATTR.name=partName3; %Name of this part
febio_spec.Mesh.Elements{3}.ATTR.type='tri3'; %Element type
febio_spec.Mesh.Elements{3}.elem.ATTR.id=size(E1,1)+size(E2,1)+(1:1:size(Fc,1))'; %Element id's
febio_spec.Mesh.Elements{3}.elem.VAL=Fc; %The element matrix

% -> NodeSets
nodeSetName1='bcSupportList';
febio_spec.Mesh.NodeSet{1}.ATTR.name=nodeSetName1;
febio_spec.Mesh.NodeSet{1}.node.ATTR.id=bcSupportList(:);

%MeshDomains section
febio_spec.MeshDomains.SolidDomain{1}.ATTR.name=partName1;
febio_spec.MeshDomains.SolidDomain{1}.ATTR.mat=materialName1;

febio_spec.MeshDomains.SolidDomain{2}.ATTR.name=partName2;
febio_spec.MeshDomains.SolidDomain{2}.ATTR.mat=materialName2;

febio_spec.MeshDomains.ShellDomain{1}.ATTR.name=partName3;
febio_spec.MeshDomains.ShellDomain{1}.ATTR.mat=materialName3;

% -> Surfaces
surfaceName1='contactSurface1';
febio_spec.Mesh.Surface{1}.ATTR.name=surfaceName1;
febio_spec.Mesh.Surface{1}.tri3.ATTR.id=(1:1:size(F_contact_primary,1))';
febio_spec.Mesh.Surface{1}.tri3.VAL=F_contact_primary;

surfaceName2='contactSurface2';
febio_spec.Mesh.Surface{2}.ATTR.name=surfaceName2;
febio_spec.Mesh.Surface{2}.tri3.ATTR.id=(1:1:size(F_contact_secondary,1))';
febio_spec.Mesh.Surface{2}.tri3.VAL=F_contact_secondary;

% -> Surface pairs
surfacePairName='Contact1';
febio_spec.Mesh.SurfacePair{1}.ATTR.name=surfacePairName;
febio_spec.Mesh.SurfacePair{1}.primary=surfaceName1;
febio_spec.Mesh.SurfacePair{1}.secondary=surfaceName2;

%MeshData section
% -> ElementData
febio_spec.MeshData.ElementData{1}.ATTR.elem_set=partName1;
febio_spec.MeshData.ElementData{1}.ATTR.var='mat_axis';

for q=1:1:size(E1,1)
    febio_spec.MeshData.ElementData{1}.elem{q}.ATTR.lid=q;
    febio_spec.MeshData.ElementData{1}.elem{q}.a=e1_dir(q,:);
    febio_spec.MeshData.ElementData{1}.elem{q}.d=e2_dir(q,:);
end

%Boundary condition section
% -> Fix boundary conditions
febio_spec.Boundary.bc{1}.ATTR.type='fix';
febio_spec.Boundary.bc{1}.ATTR.node_set=nodeSetName1;
febio_spec.Boundary.bc{1}.dofs='x,y,z';

%Rigid section
% -> Prescribed rigid body boundary conditions
febio_spec.Rigid.rigid_constraint{1}.ATTR.name='RigidFix_1';
febio_spec.Rigid.rigid_constraint{1}.ATTR.type='fix';
febio_spec.Rigid.rigid_constraint{1}.rb=3;
febio_spec.Rigid.rigid_constraint{1}.dofs='Rx,Ry,Rz,Rv,Ru,Rw';

%Contact section
febio_spec.Contact.contact{1}.ATTR.surface_pair=surfacePairName;
febio_spec.Contact.contact{1}.ATTR.type='sliding-elastic';
febio_spec.Contact.contact{1}.two_pass=1;
febio_spec.Contact.contact{1}.laugon=laugon;
febio_spec.Contact.contact{1}.tolerance=0.2;
febio_spec.Contact.contact{1}.gaptol=0;
febio_spec.Contact.contact{1}.minaug=minaug;
febio_spec.Contact.contact{1}.maxaug=maxaug;
febio_spec.Contact.contact{1}.search_tol=0.01;
febio_spec.Contact.contact{1}.search_radius=0.1;
febio_spec.Contact.contact{1}.symmetric_stiffness=0;
febio_spec.Contact.contact{1}.auto_penalty=1;
febio_spec.Contact.contact{1}.penalty=contactPenalty;
febio_spec.Contact.contact{1}.fric_coeff=fric_coeff;

%LoadData section
% -> load_controller
febio_spec.LoadData.load_controller{1}.ATTR.id=1;
febio_spec.LoadData.load_controller{1}.ATTR.type='loadcurve';
febio_spec.LoadData.load_controller{1}.interpolate='LINEAR';
febio_spec.LoadData.load_controller{1}.points.point.VAL=[0 0; 1 1];

%Output section
% -> log file
febio_spec.Output.logfile.ATTR.file=febioLogFileName;
febio_spec.Output.logfile.node_data{1}.ATTR.file=febioLogFileName_disp;
febio_spec.Output.logfile.node_data{1}.ATTR.data='ux;uy;uz';
febio_spec.Output.logfile.node_data{1}.ATTR.delim=',';

Quick viewing of the FEBio input file structure

The febView function can be used to view the xml structure in a MATLAB figure window.

febView(febio_spec); %Viewing the febio file

Exporting the FEBio input file

Exporting the febio_spec structure to an FEBio input file is done using the febioStruct2xml function.

febioStruct2xml(febio_spec,febioFebFileName); %Exporting to file and domNode

Running the FEBio analysis

To run the analysis defined by the created FEBio input file the runMonitorFEBio function is used. The input for this function is a structure defining job settings e.g. the FEBio input file name. The optional output runFlag informs the user if the analysis was run succesfully.

febioAnalysis.run_filename=febioFebFileName; %The input file name
febioAnalysis.run_logname=febioLogFileName; %The name for the log file
febioAnalysis.disp_on=1; %Display information on the command window
febioAnalysis.runMode='internal';%'internal';

[runFlag]=runMonitorFEBio(febioAnalysis);%START FEBio NOW!!!!!!!!
 
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
-------->    RUNNING/MONITORING FEBIO JOB    <-------- 18-Dec-2020 14:43:45
FEBio path: /home/kevin/FEBioStudio/bin/febio3
# Attempt removal of existing log files                18-Dec-2020 14:43:45
 * Removal succesful                                   18-Dec-2020 14:43:45
# Attempt removal of existing .xplt files              18-Dec-2020 14:43:45
 * Removal succesful                                   18-Dec-2020 14:43:45
# Starting FEBio...                                    18-Dec-2020 14:43:45
  Max. total analysis time is: Inf s

===========================================================================
         ________    _________   _______       __     _________            
        |        |\ |        |\ |       \\    |  |\  /         \\          
        |    ____|| |    ____|| |    __  ||   |__|| |    ___    ||         
        |   |\___\| |   |\___\| |   |\_| ||    \_\| |   //  \   ||         
        |   ||__    |   ||__    |   ||_| ||   |  |\ |  ||    |  ||         
        |       |\  |       |\  |         \\  |  || |  ||    |  ||         
        |    ___||  |    ___||  |    ___   || |  || |  ||    |  ||         
        |   |\__\|  |   |\__\|  |   |\__|  || |  || |  ||    |  ||         
        |   ||      |   ||___   |   ||__|  || |  || |   \\__/   ||         
        |   ||      |        |\ |          || |  || |           ||         
        |___||      |________|| |_________//  |__||  \_________//          
                                                                           
      F I N I T E   E L E M E N T S   F O R   B I O M E C H A N I C S      
                                                                           
  version 3.1.0
  FEBio is a registered trademark.                                         
  copyright (c) 2006-2020 - All rights reserved                            
                                                                           
===========================================================================

Default linear solver: pardiso
Reading file /mnt/data/MATLAB/GIBBON/data/temp/tempModel.feb ...SUCCESS!

Setting parameter "T0" to : 0

 ]0;(0%) tempModel.feb - FEBio 3.1.0  
 *************************************************************************
 *                               WARNING                                 *
 *                                                                       *
 * The sliding-elastic contact algorithm runs better with a              *
 * non-symmetric stiffness matrix.                                       *
 * You may set symmetric_stiffness flag to 0 in Control section.         *
 *                                                                       *
 *************************************************************************

===== beginning time step 1 : 0.04 =====

Setting parameter "T0" to : 0.04

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.268385
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    3.678065e-05    0.000000e+00 
	   energy              1.497800e-03    2.239074e-04    1.497800e-05 
	   displacement        1.075236e+03    7.744963e+01    7.744963e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    1.822281e-04    0.000000e+00 
	   energy              1.497800e-03    4.920860e-06    1.497800e-05 
	   displacement        1.075236e+03    8.031625e+01    2.999147e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    1.994613e-05    0.000000e+00 
	   energy              1.497800e-03    4.627644e-05    1.497800e-05 
	   displacement        1.075236e+03    3.249157e+01    5.220178e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 4
	step from line search         = 0.392297
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    2.887498e-05    0.000000e+00 
	   energy              1.497800e-03    7.265715e-06    1.497800e-05 
	   displacement        1.075236e+03    2.045991e+01    7.420084e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    7.609339e-05    0.000000e+00 
	   energy              1.497800e-03    4.572896e-06    1.497800e-05 
	   displacement        1.075236e+03    3.488658e+01    1.086276e-03 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    4.179678e-06    0.000000e+00 
	   energy              1.497800e-03    1.683353e-05    1.497800e-05 
	   displacement        1.075236e+03    1.045620e+01    1.306506e-03 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 7
	step from line search         = 0.625859
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    1.438224e-05    0.000000e+00 
	   energy              1.497800e-03    4.495925e-06    1.497800e-05 
	   displacement        1.075236e+03    1.466637e+01    1.595299e-03 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    3.001567e-06    0.000000e+00 
	   energy              1.497800e-03    5.594930e-06    1.497800e-05 
	   displacement        1.075236e+03    8.662962e+00    1.837405e-03 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    2.070138e-06    0.000000e+00 
	   energy              1.497800e-03    1.368344e-06    1.497800e-05 
	   displacement        1.075236e+03    6.715870e+00    2.064709e-03 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 14
	stiffness matrix reformations = 10
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    8.577866e-08    0.000000e+00 
	   energy              1.497800e-03    4.488001e-07    1.497800e-05 
	   displacement        1.075236e+03    1.402905e+00    2.173200e-03 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 11
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    6.781207e-09    0.000000e+00 
	   energy              1.497800e-03    2.447005e-08    1.497800e-05 
	   displacement        1.075236e+03    3.865307e-01    2.231236e-03 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 16
	stiffness matrix reformations = 12
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    1.493516e-12    0.000000e+00 
	   energy              1.497800e-03    9.142128e-12    1.497800e-05 
	   displacement        1.075236e+03    4.823008e-03    2.237750e-03 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.04
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 13
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.323562e-07    6.343833e-15    0.000000e+00 
	   energy              1.497800e-03    2.770176e-12    1.497800e-05 
	   displacement        1.075236e+03    2.314349e-06    2.237825e-03 

convergence summary
    number of iterations   : 13
    number of reformations : 13

------- converged at time : 0.04


Data Record #1
===========================================================================
Step = 1
Time = 0.04
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(4%) tempModel.feb - FEBio 3.1.0  
===== beginning time step 2 : 0.08 =====

Setting parameter "T0" to : 0.08

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.492216
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    1.975007e-04    0.000000e+00 
	   energy              1.196668e-03    1.723448e-04    1.196668e-05 
	   displacement        2.968339e+02    7.191605e+01    7.191605e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    9.500480e-06    0.000000e+00 
	   energy              1.196668e-03    6.818145e-05    1.196668e-05 
	   displacement        2.968339e+02    3.092113e+01    1.945456e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.403379
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    4.576005e-05    0.000000e+00 
	   energy              1.196668e-03    2.762891e-05    1.196668e-05 
	   displacement        2.968339e+02    2.679514e+01    3.577260e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    4.908787e-05    0.000000e+00 
	   energy              1.196668e-03    1.637261e-05    1.196668e-05 
	   displacement        2.968339e+02    4.371255e+01    6.428293e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    1.158404e-05    0.000000e+00 
	   energy              1.196668e-03    1.748355e-05    1.196668e-05 
	   displacement        2.968339e+02    1.508023e+01    8.483608e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    2.449581e-05    0.000000e+00 
	   energy              1.196668e-03    1.373875e-06    1.196668e-05 
	   displacement        2.968339e+02    2.308444e+01    1.148252e-03 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    1.087052e-06    0.000000e+00 
	   energy              1.196668e-03    5.127024e-06    1.196668e-05 
	   displacement        2.968339e+02    5.070540e+00    1.304106e-03 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    4.238207e-06    0.000000e+00 
	   energy              1.196668e-03    8.741802e-07    1.196668e-05 
	   displacement        2.968339e+02    8.981108e+00    1.527933e-03 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    1.261398e-08    0.000000e+00 
	   energy              1.196668e-03    2.765886e-07    1.196668e-05 
	   displacement        2.968339e+02    5.226238e-01    1.584719e-03 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 10
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    5.017788e-09    0.000000e+00 
	   energy              1.196668e-03    5.388133e-09    1.196668e-05 
	   displacement        2.968339e+02    3.112938e-01    1.629170e-03 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.08
	stiffness updates             = 0
	right hand side evaluations   = 14
	stiffness matrix reformations = 11
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.217581e-07    4.326629e-13    0.000000e+00 
	   energy              1.196668e-03    1.042633e-11    1.196668e-05 
	   displacement        2.968339e+02    4.019181e-04    1.630766e-03 

convergence summary
    number of iterations   : 11
    number of reformations : 11

------- converged at time : 0.08


Data Record #1
===========================================================================
Step = 2
Time = 0.08
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(8%) tempModel.feb - FEBio 3.1.0  
===== beginning time step 3 : 0.12 =====

Setting parameter "T0" to : 0.12

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.507671
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    1.892649e-04    0.000000e+00 
	   energy              1.107799e-03    1.576157e-04    1.107799e-05 
	   displacement        2.636008e+02    6.793769e+01    6.793769e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    7.902649e-06    0.000000e+00 
	   energy              1.107799e-03    6.419822e-05    1.107799e-05 
	   displacement        2.636008e+02    2.809953e+01    1.812956e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.399330
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    4.255451e-05    0.000000e+00 
	   energy              1.107799e-03    2.377256e-05    1.107799e-05 
	   displacement        2.636008e+02    2.714181e+01    3.413933e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    3.936433e-05    0.000000e+00 
	   energy              1.107799e-03    1.816400e-05    1.107799e-05 
	   displacement        2.636008e+02    3.739354e+01    5.965214e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    9.904954e-06    0.000000e+00 
	   energy              1.107799e-03    9.320777e-06    1.107799e-05 
	   displacement        2.636008e+02    1.223089e+01    7.716024e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    1.905790e-05    0.000000e+00 
	   energy              1.107799e-03    1.044892e-05    1.107799e-05 
	   displacement        2.636008e+02    2.125309e+01    1.046261e-03 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    7.630502e-07    0.000000e+00 
	   energy              1.107799e-03    3.326454e-06    1.107799e-05 
	   displacement        2.636008e+02    4.044352e+00    1.173250e-03 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    1.757747e-06    0.000000e+00 
	   energy              1.107799e-03    2.385630e-07    1.107799e-05 
	   displacement        2.636008e+02    4.667451e+00    1.323634e-03 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    1.795701e-08    0.000000e+00 
	   energy              1.107799e-03    2.897877e-07    1.107799e-05 
	   displacement        2.636008e+02    6.724903e-01    1.383455e-03 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 10
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    8.206809e-09    0.000000e+00 
	   energy              1.107799e-03    1.062953e-06    1.107799e-05 
	   displacement        2.636008e+02    5.919979e-02    1.389184e-03 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 14
	stiffness matrix reformations = 11
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    4.586274e-09    0.000000e+00 
	   energy              1.107799e-03    7.549308e-07    1.107799e-05 
	   displacement        2.636008e+02    6.539075e-02    1.401566e-03 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 12
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    2.121510e-09    0.000000e+00 
	   energy              1.107799e-03    3.444896e-07    1.107799e-05 
	   displacement        2.636008e+02    2.703453e-02    1.395098e-03 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 16
	stiffness matrix reformations = 13
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    4.474674e-10    0.000000e+00 
	   energy              1.107799e-03    9.254294e-08    1.107799e-05 
	   displacement        2.636008e+02    7.854025e-03    1.396692e-03 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.12
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 14
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.451083e-07    2.541936e-11    0.000000e+00 
	   energy              1.107799e-03    7.337934e-09    1.107799e-05 
	   displacement        2.636008e+02    1.397625e-03    1.397725e-03 

convergence summary
    number of iterations   : 14
    number of reformations : 14

------- converged at time : 0.12


Data Record #1
===========================================================================
Step = 3
Time = 0.12
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(12%) tempModel.feb - FEBio 3.1.0  
===== beginning time step 4 : 0.16 =====

Setting parameter "T0" to : 0.16

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.524309
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    1.824536e-04    0.000000e+00 
	   energy              1.028441e-03    1.448529e-04    1.028441e-05 
	   displacement        2.324944e+02    6.391280e+01    6.391280e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    6.187876e-06    0.000000e+00 
	   energy              1.028441e-03    6.095501e-05    1.028441e-05 
	   displacement        2.324944e+02    2.329864e+01    1.625758e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.383135
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    3.942038e-05    0.000000e+00 
	   energy              1.028441e-03    1.904696e-05    1.028441e-05 
	   displacement        2.324944e+02    2.821727e+01    3.192524e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    3.302117e-05    0.000000e+00 
	   energy              1.028441e-03    2.329426e-06    1.028441e-05 
	   displacement        2.324944e+02    3.576329e+01    5.576561e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    7.351608e-06    0.000000e+00 
	   energy              1.028441e-03    8.128161e-06    1.028441e-05 
	   displacement        2.324944e+02    7.206147e+00    6.754342e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 6
	step from line search         = 0.509455
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    8.847971e-06    0.000000e+00 
	   energy              1.028441e-03    2.011311e-05    1.028441e-05 
	   displacement        2.324944e+02    1.222713e+01    8.630831e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    3.294267e-06    0.000000e+00 
	   energy              1.028441e-03    1.440263e-05    1.028441e-05 
	   displacement        2.324944e+02    6.803476e+00    1.010298e-03 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    6.815624e-07    0.000000e+00 
	   energy              1.028441e-03    4.961648e-07    1.028441e-05 
	   displacement        2.324944e+02    3.011804e+00    1.120737e-03 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    1.184681e-07    0.000000e+00 
	   energy              1.028441e-03    9.107073e-08    1.028441e-05 
	   displacement        2.324944e+02    1.863312e+00    1.213343e-03 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 10
	step from line search         = 0.566575
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    2.553509e-08    0.000000e+00 
	   energy              1.028441e-03    5.334331e-07    1.028441e-05 
	   displacement        2.324944e+02    6.573804e-02    1.203612e-03 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 16
	stiffness matrix reformations = 11
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    2.463636e-09    0.000000e+00 
	   energy              1.028441e-03    3.643886e-07    1.028441e-05 
	   displacement        2.324944e+02    8.115812e-02    1.221601e-03 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 12
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    1.550684e-09    0.000000e+00 
	   energy              1.028441e-03    2.333956e-07    1.028441e-05 
	   displacement        2.324944e+02    1.668943e-02    1.215837e-03 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 18
	stiffness matrix reformations = 13
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    8.711705e-10    0.000000e+00 
	   energy              1.028441e-03    1.385075e-07    1.028441e-05 
	   displacement        2.324944e+02    1.001752e-02    1.220153e-03 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 19
	stiffness matrix reformations = 14
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    3.799033e-10    0.000000e+00 
	   energy              1.028441e-03    6.437354e-08    1.028441e-05 
	   displacement        2.324944e+02    4.344357e-03    1.217680e-03 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 20
	stiffness matrix reformations = 15
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    1.148272e-10    0.000000e+00 
	   energy              1.028441e-03    2.140145e-08    1.028441e-05 
	   displacement        2.324944e+02    1.452428e-03    1.218672e-03 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.16
	stiffness updates             = 0
	right hand side evaluations   = 21
	stiffness matrix reformations = 16
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            6.828642e-07    1.535728e-11    0.000000e+00 
	   energy              1.028441e-03    3.570940e-09    1.028441e-05 
	   displacement        2.324944e+02    3.073332e-04    1.218735e-03 

convergence summary
    number of iterations   : 16
    number of reformations : 16

------- converged at time : 0.16


Data Record #1
===========================================================================
Step = 4
Time = 0.16
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(16%) tempModel.feb - FEBio 3.1.0  
===== beginning time step 5 : 0.2 =====

Setting parameter "T0" to : 0.2

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.537330
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.785759e-04    0.000000e+00 
	   energy              9.791478e-04    1.372701e-04    9.791478e-06 
	   displacement        2.177193e+02    6.286067e+01    6.286067e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    5.060715e-06    0.000000e+00 
	   energy              9.791478e-04    5.723564e-05    9.791478e-06 
	   displacement        2.177193e+02    2.073623e+01    1.542224e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.415498
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    3.400291e-05    0.000000e+00 
	   energy              9.791478e-04    2.461062e-05    9.791478e-06 
	   displacement        2.177193e+02    2.183267e+01    2.860316e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    4.457799e-05    0.000000e+00 
	   energy              9.791478e-04    6.206484e-05    9.791478e-06 
	   displacement        2.177193e+02    4.856955e+01    5.627277e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 5
	step from line search         = 0.613600
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.186704e-05    0.000000e+00 
	   energy              9.791478e-04    1.167623e-05    9.791478e-06 
	   displacement        2.177193e+02    6.497021e+00    6.520446e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 6
	step from line search         = 0.241806
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    8.187770e-06    0.000000e+00 
	   energy              9.791478e-04    1.076380e-05    9.791478e-06 
	   displacement        2.177193e+02    7.066591e-01    6.327487e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.518464e-05    0.000000e+00 
	   energy              9.791478e-04    4.272469e-05    9.791478e-06 
	   displacement        2.177193e+02    1.640626e+01    8.447928e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    4.821607e-07    0.000000e+00 
	   energy              9.791478e-04    2.787435e-05    9.791478e-06 
	   displacement        2.177193e+02    2.079388e+00    9.089858e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 9
	step from line search         = 0.617045
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    5.915423e-07    0.000000e+00 
	   energy              9.791478e-04    5.097831e-06    9.791478e-06 
	   displacement        2.177193e+02    3.234742e+00    1.015958e-03 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 10
	step from line search         = 0.470253
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.859199e-07    0.000000e+00 
	   energy              9.791478e-04    1.399462e-06    9.791478e-06 
	   displacement        2.177193e+02    1.097863e-01    1.008661e-03 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 19
	stiffness matrix reformations = 11
	step from line search         = 0.480612
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    8.323257e-08    0.000000e+00 
	   energy              9.791478e-04    9.297486e-07    9.791478e-06 
	   displacement        2.177193e+02    4.392161e-01    1.049506e-03 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 21
	stiffness matrix reformations = 12
	step from line search         = 0.471534
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    2.550489e-08    0.000000e+00 
	   energy              9.791478e-04    4.240165e-07    9.791478e-06 
	   displacement        2.177193e+02    3.583046e-02    1.041818e-03 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 23
	stiffness matrix reformations = 13
	step from line search         = 0.459534
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.016118e-08    0.000000e+00 
	   energy              9.791478e-04    2.155386e-07    9.791478e-06 
	   displacement        2.177193e+02    9.182535e-02    1.060575e-03 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 25
	stiffness matrix reformations = 14
	step from line search         = 0.461194
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    3.364954e-09    0.000000e+00 
	   energy              9.791478e-04    1.003299e-07    9.791478e-06 
	   displacement        2.177193e+02    1.241202e-02    1.054812e-03 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 27
	stiffness matrix reformations = 15
	step from line search         = 0.453209
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.230143e-09    0.000000e+00 
	   energy              9.791478e-04    4.927429e-08    9.791478e-06 
	   displacement        2.177193e+02    1.781996e-02    1.063012e-03 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 29
	stiffness matrix reformations = 16
	step from line search         = 0.437391
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    4.826465e-10    0.000000e+00 
	   energy              9.791478e-04    2.520933e-08    9.791478e-06 
	   displacement        2.177193e+02    4.464775e-03    1.059178e-03 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 31
	stiffness matrix reformations = 17
	step from line search         = 0.443492
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.946863e-10    0.000000e+00 
	   energy              9.791478e-04    1.382015e-08    9.791478e-06 
	   displacement        2.177193e+02    4.406488e-03    1.063230e-03 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 33
	stiffness matrix reformations = 18
	step from line search         = 0.438145
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    8.095117e-11    0.000000e+00 
	   energy              9.791478e-04    7.157301e-09    9.791478e-06 
	   displacement        2.177193e+02    1.465163e-03    1.060988e-03 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 35
	stiffness matrix reformations = 19
	step from line search         = 0.440143
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    3.586892e-11    0.000000e+00 
	   energy              9.791478e-04    3.783304e-09    9.791478e-06 
	   displacement        2.177193e+02    1.106704e-03    1.063007e-03 
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.2
	stiffness updates             = 0
	right hand side evaluations   = 37
	stiffness matrix reformations = 20
	step from line search         = 0.438009
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.308754e-07    1.616964e-11    0.000000e+00 
	   energy              9.791478e-04    1.964377e-09    9.791478e-06 
	   displacement        2.177193e+02    4.379590e-04    1.061768e-03 

convergence summary
    number of iterations   : 20
    number of reformations : 20

------- converged at time : 0.2


Data Record #1
===========================================================================
Step = 5
Time = 0.2
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(20%) tempModel.feb - FEBio 3.1.0  
===== beginning time step 6 : 0.24 =====

Setting parameter "T0" to : 0.24

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.553324
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.735404e-04    0.000000e+00 
	   energy              9.208346e-04    1.271153e-04    9.208346e-06 
	   displacement        1.948602e+02    5.965978e+01    5.965978e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    4.258907e-06    0.000000e+00 
	   energy              9.208346e-04    5.557734e-05    9.208346e-06 
	   displacement        1.948602e+02    1.874543e+01    1.439982e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.419133
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    2.844654e-05    0.000000e+00 
	   energy              9.208346e-04    2.154029e-05    9.208346e-06 
	   displacement        1.948602e+02    1.808462e+01    2.586348e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 4
	step from line search         = 0.535719
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    2.359942e-05    0.000000e+00 
	   energy              9.208346e-04    1.909429e-05    9.208346e-06 
	   displacement        1.948602e+02    2.004638e+01    4.160965e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.650542e-05    0.000000e+00 
	   energy              9.208346e-04    1.096099e-04    9.208346e-06 
	   displacement        1.948602e+02    1.764641e+01    5.721840e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 6
	step from line search         = 0.023853
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.611755e-05    0.000000e+00 
	   energy              9.208346e-04    7.997409e-07    9.208346e-06 
	   displacement        1.948602e+02    1.719548e-01    5.561068e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 7
	step from line search         = 0.092200
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.340943e-05    0.000000e+00 
	   energy              9.208346e-04    1.236103e-05    9.208346e-06 
	   displacement        1.948602e+02    2.391136e+00    6.230755e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 8
	step from line search         = 0.144342
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.096176e-05    0.000000e+00 
	   energy              9.208346e-04    3.438672e-06    9.208346e-06 
	   displacement        1.948602e+02    1.505279e+00    5.781402e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 20
	stiffness matrix reformations = 9
	step from line search         = 0.058923
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.005275e-05    0.000000e+00 
	   energy              9.208346e-04    1.390411e-05    9.208346e-06 
	   displacement        1.948602e+02    2.500979e+00    6.478500e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 22
	stiffness matrix reformations = 10
	step from line search         = 0.176525
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    7.491233e-06    0.000000e+00 
	   energy              9.208346e-04    1.519227e-06    9.208346e-06 
	   displacement        1.948602e+02    5.712860e-01    6.226493e-04 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 24
	stiffness matrix reformations = 11
	step from line search         = 0.436637
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    5.436992e-06    0.000000e+00 
	   energy              9.208346e-04    2.209696e-05    9.208346e-06 
	   displacement        1.948602e+02    6.037686e+00    7.446001e-04 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 26
	stiffness matrix reformations = 12
	step from line search         = 0.337351
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    2.744863e-06    0.000000e+00 
	   energy              9.208346e-04    6.598251e-08    9.208346e-06 
	   displacement        1.948602e+02    3.805855e-01    7.376843e-04 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 27
	stiffness matrix reformations = 13
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.829946e-06    0.000000e+00 
	   energy              9.208346e-04    1.452683e-06    9.208346e-06 
	   displacement        1.948602e+02    5.005156e+00    8.623392e-04 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 28
	stiffness matrix reformations = 14
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    4.602569e-08    0.000000e+00 
	   energy              9.208346e-04    1.742466e-07    9.208346e-06 
	   displacement        1.948602e+02    9.793344e-01    9.202169e-04 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 30
	stiffness matrix reformations = 15
	step from line search         = 0.559195
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.296941e-08    0.000000e+00 
	   energy              9.208346e-04    6.406718e-08    9.208346e-06 
	   displacement        1.948602e+02    1.074493e-02    9.240296e-04 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 32
	stiffness matrix reformations = 16
	step from line search         = 0.449152
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    5.835091e-09    0.000000e+00 
	   energy              9.208346e-04    2.249175e-07    9.208346e-06 
	   displacement        1.948602e+02    9.996545e-02    9.425481e-04 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 34
	stiffness matrix reformations = 17
	step from line search         = 0.458203
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    2.135405e-09    0.000000e+00 
	   energy              9.208346e-04    1.077283e-07    9.208346e-06 
	   displacement        1.948602e+02    1.426828e-02    9.366947e-04 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 36
	stiffness matrix reformations = 18
	step from line search         = 0.445323
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    8.290561e-10    0.000000e+00 
	   energy              9.208346e-04    5.547865e-08    9.208346e-06 
	   displacement        1.948602e+02    2.046431e-02    9.450126e-04 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 38
	stiffness matrix reformations = 19
	step from line search         = 0.458884
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    3.309954e-10    0.000000e+00 
	   energy              9.208346e-04    2.479116e-08    9.208346e-06 
	   displacement        1.948602e+02    4.247529e-03    9.415846e-04 
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 40
	stiffness matrix reformations = 20
	step from line search         = 0.447176
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.179102e-10    0.000000e+00 
	   energy              9.208346e-04    1.215516e-08    9.208346e-06 
	   displacement        1.948602e+02    3.947359e-03    9.452087e-04 
Reforming stiffness matrix: reformation #21

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 21
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 42
	stiffness matrix reformations = 21
	step from line search         = 0.457646
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    5.265170e-11    0.000000e+00 
	   energy              9.208346e-04    5.261369e-09    9.208346e-06 
	   displacement        1.948602e+02    1.052754e-03    9.434510e-04 
Reforming stiffness matrix: reformation #22

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 22
 Nonlinear solution status: time= 0.24
	stiffness updates             = 0
	right hand side evaluations   = 44
	stiffness matrix reformations = 22
	step from line search         = 0.449462
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.967444e-07    1.824362e-11    0.000000e+00 
	   energy              9.208346e-04    2.547619e-09    9.208346e-06 
	   displacement        1.948602e+02    7.580226e-04    9.450282e-04 

convergence summary
    number of iterations   : 22
    number of reformations : 22

------- converged at time : 0.24


Data Record #1
===========================================================================
Step = 6
Time = 0.24
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(24%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: decreasing time step, dt = 0.0381571


===== beginning time step 7 : 0.278157 =====

Setting parameter "T0" to : 0.278157

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.571954
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    1.597486e-04    0.000000e+00 
	   energy              8.121869e-04    1.116834e-04    8.121869e-06 
	   displacement        1.708760e+02    5.589895e+01    5.589895e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    3.194476e-06    0.000000e+00 
	   energy              8.121869e-04    4.720499e-05    8.121869e-06 
	   displacement        1.708760e+02    1.599649e+01    1.306441e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.420447
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    2.603310e-05    0.000000e+00 
	   energy              8.121869e-04    1.820009e-05    8.121869e-06 
	   displacement        1.708760e+02    1.889198e+01    2.444977e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 4
	step from line search         = 0.569179
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    1.734490e-05    0.000000e+00 
	   energy              8.121869e-04    1.222105e-05    8.121869e-06 
	   displacement        1.708760e+02    1.489919e+01    3.756509e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 5
	step from line search         = 0.543628
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    7.347008e-06    0.000000e+00 
	   energy              8.121869e-04    3.660399e-06    8.121869e-06 
	   displacement        1.708760e+02    3.606246e+00    4.240560e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 6
	step from line search         = 0.538707
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    3.807895e-06    0.000000e+00 
	   energy              8.121869e-04    2.567689e-06    8.121869e-06 
	   displacement        1.708760e+02    1.327538e+00    4.630209e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 7
	step from line search         = 0.052716
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    4.086183e-06    0.000000e+00 
	   energy              8.121869e-04    1.144681e-05    8.121869e-06 
	   displacement        1.708760e+02    2.726171e+00    5.302972e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 8
	step from line search         = 0.259895
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    2.497657e-06    0.000000e+00 
	   energy              8.121869e-04    1.967508e-07    8.121869e-06 
	   displacement        1.708760e+02    1.962536e-01    5.301412e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 18
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    5.672328e-06    0.000000e+00 
	   energy              8.121869e-04    1.153096e-05    8.121869e-06 
	   displacement        1.708760e+02    1.067217e+01    6.897164e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 20
	stiffness matrix reformations = 10
	step from line search         = 0.476299
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    1.620852e-06    0.000000e+00 
	   energy              8.121869e-04    4.825661e-06    8.121869e-06 
	   displacement        1.708760e+02    3.878384e-01    6.738018e-04 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 22
	stiffness matrix reformations = 11
	step from line search         = 0.433383
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    6.964348e-07    0.000000e+00 
	   energy              8.121869e-04    2.965487e-06    8.121869e-06 
	   displacement        1.708760e+02    9.121717e-01    7.214697e-04 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 24
	stiffness matrix reformations = 12
	step from line search         = 0.403515
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    2.817613e-07    0.000000e+00 
	   energy              8.121869e-04    2.667909e-06    8.121869e-06 
	   displacement        1.708760e+02    2.571756e-01    7.007863e-04 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 27
	stiffness matrix reformations = 13
	step from line search         = 0.265389
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    1.794783e-07    0.000000e+00 
	   energy              8.121869e-04    7.033723e-07    8.121869e-06 
	   displacement        1.708760e+02    3.768833e-01    7.317330e-04 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 29
	stiffness matrix reformations = 14
	step from line search         = 0.419414
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    6.524588e-08    0.000000e+00 
	   energy              8.121869e-04    4.007997e-07    8.121869e-06 
	   displacement        1.708760e+02    3.076376e-02    7.254052e-04 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 32
	stiffness matrix reformations = 15
	step from line search         = 0.265988
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    3.758356e-08    0.000000e+00 
	   energy              8.121869e-04    1.273009e-07    8.121869e-06 
	   displacement        1.708760e+02    8.169182e-02    7.401351e-04 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 35
	stiffness matrix reformations = 16
	step from line search         = 0.268013
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    2.031034e-08    0.000000e+00 
	   energy              8.121869e-04    2.452127e-08    8.121869e-06 
	   displacement        1.708760e+02    4.235579e-03    7.375011e-04 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 37
	stiffness matrix reformations = 17
	step from line search         = 0.429480
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    7.344781e-09    0.000000e+00 
	   energy              8.121869e-04    3.442869e-08    8.121869e-06 
	   displacement        1.708760e+02    2.186835e-02    7.453362e-04 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 40
	stiffness matrix reformations = 18
	step from line search         = 0.251765
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    4.079597e-09    0.000000e+00 
	   energy              8.121869e-04    1.219581e-08    8.121869e-06 
	   displacement        1.708760e+02    3.033901e-03    7.427730e-04 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 43
	stiffness matrix reformations = 19
	step from line search         = 0.278318
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    2.144506e-09    0.000000e+00 
	   energy              8.121869e-04    2.768732e-09    8.121869e-06 
	   displacement        1.708760e+02    2.861765e-03    7.456019e-04 
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.278157
	stiffness updates             = 0
	right hand side evaluations   = 45
	stiffness matrix reformations = 20
	step from line search         = 0.409313
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.301249e-07    7.804106e-10    0.000000e+00 
	   energy              8.121869e-04    3.671403e-09    8.121869e-06 
	   displacement        1.708760e+02    2.378251e-04    7.451173e-04 

convergence summary
    number of iterations   : 20
    number of reformations : 20

------- converged at time : 0.278157


Data Record #1
===========================================================================
Step = 7
Time = 0.278157119
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(28%) tempModel.feb - FEBio 3.1.0  
===== beginning time step 8 : 0.316314 =====

Setting parameter "T0" to : 0.316314

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.591272
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.610315e-04    0.000000e+00 
	   energy              7.843516e-04    1.064874e-04    7.843516e-06 
	   displacement        1.569113e+02    5.485663e+01    5.485663e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    2.532554e-06    0.000000e+00 
	   energy              7.843516e-04    4.507747e-05    7.843516e-06 
	   displacement        1.569113e+02    1.371068e+01    1.225034e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.422638
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    2.052313e-05    0.000000e+00 
	   energy              7.843516e-04    1.587352e-05    7.843516e-06 
	   displacement        1.569113e+02    1.451299e+01    2.173079e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 4
	step from line search         = 0.391080
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.849161e-05    0.000000e+00 
	   energy              7.843516e-04    3.382724e-05    7.843516e-06 
	   displacement        1.569113e+02    1.423786e+01    3.358735e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 5
	step from line search         = 0.505726
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    7.718357e-06    0.000000e+00 
	   energy              7.843516e-04    8.923504e-07    7.843516e-06 
	   displacement        1.569113e+02    3.229952e+00    3.734228e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 6
	step from line search         = 0.188896
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    5.484659e-06    0.000000e+00 
	   energy              7.843516e-04    1.298420e-06    7.843516e-06 
	   displacement        1.569113e+02    1.543528e-01    3.746338e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 7
	step from line search         = 0.191771
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    4.734846e-06    0.000000e+00 
	   energy              7.843516e-04    4.386147e-06    7.843516e-06 
	   displacement        1.569113e+02    2.300472e+00    4.330877e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 8
	step from line search         = 0.255506
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    2.994933e-06    0.000000e+00 
	   energy              7.843516e-04    7.555369e-07    7.843516e-06 
	   displacement        1.569113e+02    2.032961e-01    4.382198e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 20
	stiffness matrix reformations = 9
	step from line search         = 0.221656
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    2.526027e-06    0.000000e+00 
	   energy              7.843516e-04    1.873961e-06    7.843516e-06 
	   displacement        1.569113e+02    1.619935e+00    4.917125e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 22
	stiffness matrix reformations = 10
	step from line search         = 0.283353
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.511189e-06    0.000000e+00 
	   energy              7.843516e-04    4.823021e-07    7.843516e-06 
	   displacement        1.569113e+02    1.570957e-01    4.960204e-04 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 25
	stiffness matrix reformations = 11
	step from line search         = 0.147987
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.355743e-06    0.000000e+00 
	   energy              7.843516e-04    1.828768e-06    7.843516e-06 
	   displacement        1.569113e+02    9.535095e-01    5.387749e-04 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 27
	stiffness matrix reformations = 12
	step from line search         = 0.313732
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    7.635654e-07    0.000000e+00 
	   energy              7.843516e-04    1.222388e-06    7.843516e-06 
	   displacement        1.569113e+02    1.249430e-01    5.404451e-04 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 30
	stiffness matrix reformations = 13
	step from line search         = 0.116149
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    7.275258e-07    0.000000e+00 
	   energy              7.843516e-04    1.940224e-06    7.843516e-06 
	   displacement        1.569113e+02    7.784026e-01    5.802099e-04 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 32
	stiffness matrix reformations = 14
	step from line search         = 0.306057
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    4.120318e-07    0.000000e+00 
	   energy              7.843516e-04    1.406902e-06    7.843516e-06 
	   displacement        1.569113e+02    1.087989e-01    5.749871e-04 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 35
	stiffness matrix reformations = 15
	step from line search         = 0.146547
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    3.788973e-07    0.000000e+00 
	   energy              7.843516e-04    1.419879e-06    7.843516e-06 
	   displacement        1.569113e+02    6.493088e-01    6.124633e-04 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 37
	stiffness matrix reformations = 16
	step from line search         = 0.347051
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    2.047548e-07    0.000000e+00 
	   energy              7.843516e-04    1.752820e-06    7.843516e-06 
	   displacement        1.569113e+02    1.199420e-01    6.029963e-04 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 40
	stiffness matrix reformations = 17
	step from line search         = 0.130860
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.995205e-07    0.000000e+00 
	   energy              7.843516e-04    1.562372e-06    7.843516e-06 
	   displacement        1.569113e+02    6.050324e-01    6.396736e-04 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 43
	stiffness matrix reformations = 18
	step from line search         = 0.220332
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.333454e-07    0.000000e+00 
	   energy              7.843516e-04    4.118695e-07    7.843516e-06 
	   displacement        1.569113e+02    8.327155e-02    6.282262e-04 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 46
	stiffness matrix reformations = 19
	step from line search         = 0.182330
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    9.813722e-08    0.000000e+00 
	   energy              7.843516e-04    2.570860e-07    7.843516e-06 
	   displacement        1.569113e+02    1.523937e-01    6.471905e-04 
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 49
	stiffness matrix reformations = 20
	step from line search         = 0.249799
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    5.950213e-08    0.000000e+00 
	   energy              7.843516e-04    1.241054e-07    7.843516e-06 
	   displacement        1.569113e+02    1.710526e-02    6.428157e-04 
Reforming stiffness matrix: reformation #21

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 21
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 52
	stiffness matrix reformations = 21
	step from line search         = 0.170181
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    4.340290e-08    0.000000e+00 
	   energy              7.843516e-04    1.338385e-07    7.843516e-06 
	   displacement        1.569113e+02    7.554330e-02    6.562731e-04 
Reforming stiffness matrix: reformation #22

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 22
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 55
	stiffness matrix reformations = 22
	step from line search         = 0.242438
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    2.669878e-08    0.000000e+00 
	   energy              7.843516e-04    6.275399e-08    7.843516e-06 
	   displacement        1.569113e+02    9.617465e-03    6.526785e-04 
Reforming stiffness matrix: reformation #23

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 23
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 58
	stiffness matrix reformations = 23
	step from line search         = 0.235033
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.643452e-08    0.000000e+00 
	   energy              7.843516e-04    5.005569e-08    7.843516e-06 
	   displacement        1.569113e+02    4.115331e-02    6.627408e-04 
Reforming stiffness matrix: reformation #24

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 24
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 61
	stiffness matrix reformations = 24
	step from line search         = 0.243550
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    9.900846e-09    0.000000e+00 
	   energy              7.843516e-04    2.330788e-08    7.843516e-06 
	   displacement        1.569113e+02    3.516007e-03    6.605651e-04 
Reforming stiffness matrix: reformation #25

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 25
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 64
	stiffness matrix reformations = 25
	step from line search         = 0.270943
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    5.453310e-09    0.000000e+00 
	   energy              7.843516e-04    1.606079e-08    7.843516e-06 
	   displacement        1.569113e+02    1.682380e-02    6.670500e-04 
Reforming stiffness matrix: reformation #26

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 26
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 67
	stiffness matrix reformations = 26
	step from line search         = 0.242202
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    3.232070e-09    0.000000e+00 
	   energy              7.843516e-04    7.653033e-09    7.843516e-06 
	   displacement        1.569113e+02    1.125459e-03    6.658216e-04 
Reforming stiffness matrix: reformation #27

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 27
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 70
	stiffness matrix reformations = 27
	step from line search         = 0.264622
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.778812e-09    0.000000e+00 
	   energy              7.843516e-04    4.857884e-09    7.843516e-06 
	   displacement        1.569113e+02    5.287647e-03    6.694726e-04 
Reforming stiffness matrix: reformation #28

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 28
 Nonlinear solution status: time= 0.316314
	stiffness updates             = 0
	right hand side evaluations   = 73
	stiffness matrix reformations = 28
	step from line search         = 0.243557
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.108140e-07    1.038440e-09    0.000000e+00 
	   energy              7.843516e-04    2.448778e-09    7.843516e-06 
	   displacement        1.569113e+02    3.486143e-04    6.687984e-04 

convergence summary
    number of iterations   : 28
    number of reformations : 28

------- converged at time : 0.316314


Data Record #1
===========================================================================
Step = 8
Time = 0.316314237
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(32%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: decreasing time step, dt = 0.0323106


===== beginning time step 9 : 0.348625 =====

Setting parameter "T0" to : 0.348625

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 1
	step from line search         = 0.625374
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.282081e-04    0.000000e+00 
	   energy              5.748306e-04    7.770951e-05    5.748306e-06 
	   displacement        1.218238e+02    4.764442e+01    4.764442e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.403249e-06    0.000000e+00 
	   energy              5.748306e-04    3.110394e-05    5.748306e-06 
	   displacement        1.218238e+02    9.781109e+00    9.994560e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 3
	step from line search         = 0.455998
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.200021e-05    0.000000e+00 
	   energy              5.748306e-04    8.354591e-06    5.748306e-06 
	   displacement        1.218238e+02    1.027633e+01    1.717258e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 4
	step from line search         = 0.204331
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.031509e-05    0.000000e+00 
	   energy              5.748306e-04    8.649164e-06    5.748306e-06 
	   displacement        1.218238e+02    4.703873e+00    2.291693e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 5
	step from line search         = 0.372501
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    4.899872e-06    0.000000e+00 
	   energy              5.748306e-04    3.152612e-06    5.748306e-06 
	   displacement        1.218238e+02    7.102189e-01    2.420936e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 6
	step from line search         = 0.552284
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    4.113624e-06    0.000000e+00 
	   energy              5.748306e-04    2.136835e-06    5.748306e-06 
	   displacement        1.218238e+02    5.315826e+00    3.181003e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 7
	step from line search         = 0.143153
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    3.036885e-06    0.000000e+00 
	   energy              5.748306e-04    8.390570e-07    5.748306e-06 
	   displacement        1.218238e+02    3.902153e-01    3.017977e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 17
	stiffness matrix reformations = 8
	step from line search         = 0.390125
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    2.069731e-06    0.000000e+00 
	   energy              5.748306e-04    3.274821e-06    5.748306e-06 
	   displacement        1.218238e+02    2.198023e+00    3.543732e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 19
	stiffness matrix reformations = 9
	step from line search         = 0.134517
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.561940e-06    0.000000e+00 
	   energy              5.748306e-04    6.343020e-07    5.748306e-06 
	   displacement        1.218238e+02    3.015750e-01    3.383034e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 22
	stiffness matrix reformations = 10
	step from line search         = 0.252228
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.088659e-06    0.000000e+00 
	   energy              5.748306e-04    5.033526e-07    5.748306e-06 
	   displacement        1.218238e+02    6.263274e-01    3.674285e-04 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 24
	stiffness matrix reformations = 11
	step from line search         = 0.124459
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    8.390785e-07    0.000000e+00 
	   energy              5.748306e-04    3.663636e-07    5.748306e-06 
	   displacement        1.218238e+02    8.339247e-02    3.592352e-04 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 27
	stiffness matrix reformations = 12
	step from line search         = 0.196394
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    6.380518e-07    0.000000e+00 
	   energy              5.748306e-04    4.518731e-07    5.748306e-06 
	   displacement        1.218238e+02    3.845655e-01    3.824876e-04 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 29
	stiffness matrix reformations = 13
	step from line search         = 0.128055
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    4.883126e-07    0.000000e+00 
	   energy              5.748306e-04    3.441673e-07    5.748306e-06 
	   displacement        1.218238e+02    6.427249e-02    3.749479e-04 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 32
	stiffness matrix reformations = 14
	step from line search         = 0.171790
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    3.859652e-07    0.000000e+00 
	   energy              5.748306e-04    3.798052e-07    5.748306e-06 
	   displacement        1.218238e+02    2.687335e-01    3.946656e-04 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 34
	stiffness matrix reformations = 15
	step from line search         = 0.130052
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    2.947466e-07    0.000000e+00 
	   energy              5.748306e-04    3.226697e-07    5.748306e-06 
	   displacement        1.218238e+02    5.545828e-02    3.872709e-04 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 37
	stiffness matrix reformations = 16
	step from line search         = 0.155891
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    2.389987e-07    0.000000e+00 
	   energy              5.748306e-04    3.214789e-07    5.748306e-06 
	   displacement        1.218238e+02    1.979170e-01    4.043654e-04 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 39
	stiffness matrix reformations = 17
	step from line search         = 0.132469
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.823519e-07    0.000000e+00 
	   energy              5.748306e-04    3.066069e-07    5.748306e-06 
	   displacement        1.218238e+02    5.101347e-02    3.969268e-04 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 42
	stiffness matrix reformations = 18
	step from line search         = 0.144472
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.510508e-07    0.000000e+00 
	   energy              5.748306e-04    2.831545e-07    5.748306e-06 
	   displacement        1.218238e+02    1.543768e-01    4.121258e-04 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 44
	stiffness matrix reformations = 19
	step from line search         = 0.134486
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.156097e-07    0.000000e+00 
	   energy              5.748306e-04    2.947798e-07    5.748306e-06 
	   displacement        1.218238e+02    4.968996e-02    4.044806e-04 
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 47
	stiffness matrix reformations = 20
	step from line search         = 0.136511
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    9.757443e-08    0.000000e+00 
	   energy              5.748306e-04    2.581825e-07    5.748306e-06 
	   displacement        1.218238e+02    1.270751e-01    4.183293e-04 
Reforming stiffness matrix: reformation #21

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 21
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 49
	stiffness matrix reformations = 21
	step from line search         = 0.135647
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    7.535696e-08    0.000000e+00 
	   energy              5.748306e-04    2.857665e-07    5.748306e-06 
	   displacement        1.218238e+02    5.039509e-02    4.103745e-04 
Reforming stiffness matrix: reformation #22

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 22
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 52
	stiffness matrix reformations = 22
	step from line search         = 0.131059
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    6.470820e-08    0.000000e+00 
	   energy              5.748306e-04    2.417488e-07    5.748306e-06 
	   displacement        1.218238e+02    1.094280e-01    4.232592e-04 
Reforming stiffness matrix: reformation #23

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 23
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 55
	stiffness matrix reformations = 23
	step from line search         = 0.094827
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    5.291298e-08    0.000000e+00 
	   energy              5.748306e-04    7.612692e-08    5.748306e-06 
	   displacement        1.218238e+02    2.539646e-02    4.174583e-04 
Reforming stiffness matrix: reformation #24

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 24
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 58
	stiffness matrix reformations = 24
	step from line search         = 0.146383
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    4.104784e-08    0.000000e+00 
	   energy              5.748306e-04    5.436877e-08    5.748306e-06 
	   displacement        1.218238e+02    3.449319e-02    4.248313e-04 
Reforming stiffness matrix: reformation #25

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 25
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 61
	stiffness matrix reformations = 25
	step from line search         = 0.124161
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    3.172174e-08    0.000000e+00 
	   energy              5.748306e-04    6.373817e-08    5.748306e-06 
	   displacement        1.218238e+02    1.206581e-02    4.209292e-04 
Reforming stiffness matrix: reformation #26

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 26
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 64
	stiffness matrix reformations = 26
	step from line search         = 0.132739
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    2.553091e-08    0.000000e+00 
	   energy              5.748306e-04    6.055877e-08    5.748306e-06 
	   displacement        1.218238e+02    3.116078e-02    4.279114e-04 
Reforming stiffness matrix: reformation #27

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 27
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 67
	stiffness matrix reformations = 27
	step from line search         = 0.119050
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    2.000393e-08    0.000000e+00 
	   energy              5.748306e-04    5.734305e-08    5.748306e-06 
	   displacement        1.218238e+02    1.209593e-02    4.238951e-04 
Reforming stiffness matrix: reformation #28

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 28
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 70
	stiffness matrix reformations = 28
	step from line search         = 0.128534
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.622692e-08    0.000000e+00 
	   energy              5.748306e-04    4.987911e-08    5.748306e-06 
	   displacement        1.218238e+02    2.406067e-02    4.300319e-04 
Reforming stiffness matrix: reformation #29

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 29
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 73
	stiffness matrix reformations = 29
	step from line search         = 0.118167
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.276061e-08    0.000000e+00 
	   energy              5.748306e-04    4.720814e-08    5.748306e-06 
	   displacement        1.218238e+02    1.035992e-02    4.262643e-04 
Reforming stiffness matrix: reformation #30

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 30
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 76
	stiffness matrix reformations = 30
	step from line search         = 0.125659
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.039951e-08    0.000000e+00 
	   energy              5.748306e-04    4.003186e-08    5.748306e-06 
	   displacement        1.218238e+02    1.840881e-02    4.316326e-04 
Reforming stiffness matrix: reformation #31

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 31
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 79
	stiffness matrix reformations = 31
	step from line search         = 0.116312
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    8.210192e-09    0.000000e+00 
	   energy              5.748306e-04    3.691569e-08    5.748306e-06 
	   displacement        1.218238e+02    8.486288e-03    4.281880e-04 
Reforming stiffness matrix: reformation #32

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 32
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 82
	stiffness matrix reformations = 32
	step from line search         = 0.123727
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    6.700155e-09    0.000000e+00 
	   energy              5.748306e-04    3.061732e-08    5.748306e-06 
	   displacement        1.218238e+02    1.363254e-02    4.328086e-04 
Reforming stiffness matrix: reformation #33

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 33
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 85
	stiffness matrix reformations = 33
	step from line search         = 0.114523
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    5.300801e-09    0.000000e+00 
	   energy              5.748306e-04    2.754708e-08    5.748306e-06 
	   displacement        1.218238e+02    6.588412e-03    4.297516e-04 
Reforming stiffness matrix: reformation #34

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 34
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 88
	stiffness matrix reformations = 34
	step from line search         = 0.122338
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    4.323221e-09    0.000000e+00 
	   energy              5.748306e-04    2.247769e-08    5.748306e-06 
	   displacement        1.218238e+02    9.789591e-03    4.336683e-04 
Reforming stiffness matrix: reformation #35

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 35
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 91
	stiffness matrix reformations = 35
	step from line search         = 0.113207
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    3.421001e-09    0.000000e+00 
	   energy              5.748306e-04    1.993431e-08    5.748306e-06 
	   displacement        1.218238e+02    4.911671e-03    4.310151e-04 
Reforming stiffness matrix: reformation #36

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 36
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 94
	stiffness matrix reformations = 36
	step from line search         = 0.121268
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    2.786460e-09    0.000000e+00 
	   energy              5.748306e-04    1.609582e-08    5.748306e-06 
	   displacement        1.218238e+02    6.894605e-03    4.343026e-04 
Reforming stiffness matrix: reformation #37

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 37
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 97
	stiffness matrix reformations = 37
	step from line search         = 0.112192
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    2.202874e-09    0.000000e+00 
	   energy              5.748306e-04    1.413593e-08    5.748306e-06 
	   displacement        1.218238e+02    3.566151e-03    4.320329e-04 
Reforming stiffness matrix: reformation #38

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 38
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 100
	stiffness matrix reformations = 38
	step from line search         = 0.120420
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.791716e-09    0.000000e+00 
	   energy              5.748306e-04    1.132699e-08    5.748306e-06 
	   displacement        1.218238e+02    4.788276e-03    4.347730e-04 
Reforming stiffness matrix: reformation #39

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 39
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 103
	stiffness matrix reformations = 39
	step from line search         = 0.111419
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.414073e-09    0.000000e+00 
	   energy              5.748306e-04    9.882870e-09    5.748306e-06 
	   displacement        1.218238e+02    2.541080e-03    4.328511e-04 
Reforming stiffness matrix: reformation #40

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 40
 Nonlinear solution status: time= 0.348625
	stiffness updates             = 0
	right hand side evaluations   = 106
	stiffness matrix reformations = 40
	step from line search         = 0.119737
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.534314e-07    1.149701e-09    0.000000e+00 
	   energy              5.748306e-04    7.866369e-09    5.748306e-06 
	   displacement        1.218238e+02    3.291760e-03    4.351231e-04 
Reforming stiffness matrix: reformation #41


 *************************************************************************
 *                                ERROR                                  *
 *                                                                       *
 * Max nr of reformations reached.                                       *
 *                                                                       *
 *************************************************************************


------- failed to converge at time : 0.348625

Retrying time step. Retry attempt 1 of max 5


AUTO STEPPER: retry step, dt = 0.0269255


===== beginning time step 9 : 0.34324 =====

Setting parameter "T0" to : 0.34324

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    5.531093e-04    0.000000e+00 
	   energy              4.233504e-04    3.451726e-04    4.233504e-06 
	   displacement        9.883871e+01    9.883871e+01    9.883871e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    5.377250e-08    0.000000e+00 
	   energy              4.233504e-04    1.174763e-05    4.233504e-06 
	   displacement        9.883871e+01    1.822716e+00    1.253401e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.437222
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    3.262641e-06    0.000000e+00 
	   energy              4.233504e-04    3.303932e-06    4.233504e-06 
	   displacement        9.883871e+01    6.409642e+00    1.871151e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.400167e-06    0.000000e+00 
	   energy              4.233504e-04    1.982232e-06    4.233504e-06 
	   displacement        9.883871e+01    4.970325e+00    2.521949e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 5
	step from line search         = 0.204474
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.019912e-06    0.000000e+00 
	   energy              4.233504e-04    6.524835e-07    4.233504e-06 
	   displacement        9.883871e+01    4.627965e-01    2.733794e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 6
	step from line search         = 0.163016
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    6.957184e-07    0.000000e+00 
	   energy              4.233504e-04    7.403493e-08    4.233504e-06 
	   displacement        9.883871e+01    6.854274e-02    2.671501e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 7
	step from line search         = 0.458348
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    3.190568e-07    0.000000e+00 
	   energy              4.233504e-04    5.467765e-07    4.233504e-06 
	   displacement        9.883871e+01    6.009096e-01    2.926201e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 8
	step from line search         = 0.112516
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    2.469585e-07    0.000000e+00 
	   energy              4.233504e-04    2.786812e-07    4.233504e-06 
	   displacement        9.883871e+01    1.596660e-01    2.806227e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 18
	stiffness matrix reformations = 9
	step from line search         = 0.197719
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.721739e-07    0.000000e+00 
	   energy              4.233504e-04    1.029824e-07    4.233504e-06 
	   displacement        9.883871e+01    9.026290e-02    2.904999e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 20
	stiffness matrix reformations = 10
	step from line search         = 0.154716
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.218138e-07    0.000000e+00 
	   energy              4.233504e-04    5.878929e-08    4.233504e-06 
	   displacement        9.883871e+01    1.417601e-02    2.873749e-04 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 23
	stiffness matrix reformations = 11
	step from line search         = 0.192958
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    8.472380e-08    0.000000e+00 
	   energy              4.233504e-04    5.582019e-08    4.233504e-06 
	   displacement        9.883871e+01    4.982165e-02    2.947926e-04 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 25
	stiffness matrix reformations = 12
	step from line search         = 0.167280
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    5.835038e-08    0.000000e+00 
	   energy              4.233504e-04    5.201787e-08    4.233504e-06 
	   displacement        9.883871e+01    9.318008e-03    2.922006e-04 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 28
	stiffness matrix reformations = 13
	step from line search         = 0.172487
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    4.221138e-08    0.000000e+00 
	   energy              4.233504e-04    4.253476e-08    4.233504e-06 
	   displacement        9.883871e+01    3.064273e-02    2.980286e-04 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 30
	stiffness matrix reformations = 14
	step from line search         = 0.179963
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    2.832059e-08    0.000000e+00 
	   energy              4.233504e-04    4.467609e-08    4.233504e-06 
	   displacement        9.883871e+01    6.931545e-03    2.957164e-04 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 33
	stiffness matrix reformations = 15
	step from line search         = 0.126988
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    2.263083e-08    0.000000e+00 
	   energy              4.233504e-04    4.292285e-08    4.233504e-06 
	   displacement        9.883871e+01    2.083308e-02    3.004936e-04 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 35
	stiffness matrix reformations = 16
	step from line search         = 0.174911
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.545688e-08    0.000000e+00 
	   energy              4.233504e-04    4.006978e-08    4.233504e-06 
	   displacement        9.883871e+01    7.102581e-03    2.980099e-04 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 38
	stiffness matrix reformations = 17
	step from line search         = 0.123406
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.240888e-08    0.000000e+00 
	   energy              4.233504e-04    3.455257e-08    4.233504e-06 
	   displacement        9.883871e+01    1.560292e-02    3.021442e-04 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 40
	stiffness matrix reformations = 18
	step from line search         = 0.180828
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    8.460309e-09    0.000000e+00 
	   energy              4.233504e-04    3.611648e-08    4.233504e-06 
	   displacement        9.883871e+01    6.575968e-03    2.996885e-04 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 43
	stiffness matrix reformations = 19
	step from line search         = 0.120704
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    6.820171e-09    0.000000e+00 
	   energy              4.233504e-04    3.071005e-08    4.233504e-06 
	   displacement        9.883871e+01    1.288983e-02    3.034412e-04 
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 46
	stiffness matrix reformations = 20
	step from line search         = 0.127725
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    5.127924e-09    0.000000e+00 
	   energy              4.233504e-04    9.005926e-09    4.233504e-06 
	   displacement        9.883871e+01    3.189633e-03    3.016892e-04 
Reforming stiffness matrix: reformation #21

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 21
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 49
	stiffness matrix reformations = 21
	step from line search         = 0.130255
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    3.941511e-09    0.000000e+00 
	   energy              4.233504e-04    5.700163e-09    4.233504e-06 
	   displacement        9.883871e+01    3.056702e-03    3.035413e-04 
Reforming stiffness matrix: reformation #22

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 22
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 52
	stiffness matrix reformations = 22
	step from line search         = 0.156428
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    2.812806e-09    0.000000e+00 
	   energy              4.233504e-04    4.050431e-09    4.233504e-06 
	   displacement        9.883871e+01    8.455776e-04    3.026801e-04 
Reforming stiffness matrix: reformation #23

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 23
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 55
	stiffness matrix reformations = 23
	step from line search         = 0.127705
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    2.165421e-09    0.000000e+00 
	   energy              4.233504e-04    3.771864e-09    4.233504e-06 
	   displacement        9.883871e+01    1.932292e-03    3.041520e-04 
Reforming stiffness matrix: reformation #24

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 24
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 58
	stiffness matrix reformations = 24
	step from line search         = 0.158591
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.542049e-09    0.000000e+00 
	   energy              4.233504e-04    2.816681e-09    4.233504e-06 
	   displacement        9.883871e+01    5.890394e-04    3.034232e-04 
Reforming stiffness matrix: reformation #25

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 25
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 61
	stiffness matrix reformations = 25
	step from line search         = 0.125511
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    1.188127e-09    0.000000e+00 
	   energy              4.233504e-04    2.546352e-09    4.233504e-06 
	   displacement        9.883871e+01    1.245943e-03    3.046039e-04 
Reforming stiffness matrix: reformation #26

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 26
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 64
	stiffness matrix reformations = 26
	step from line search         = 0.158087
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    8.492235e-10    0.000000e+00 
	   energy              4.233504e-04    1.871391e-09    4.233504e-06 
	   displacement        9.883871e+01    4.058436e-04    3.039912e-04 
Reforming stiffness matrix: reformation #27

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 27
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 67
	stiffness matrix reformations = 27
	step from line search         = 0.124297
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    6.532680e-10    0.000000e+00 
	   energy              4.233504e-04    1.635685e-09    4.233504e-06 
	   displacement        9.883871e+01    7.769649e-04    3.049230e-04 
Reforming stiffness matrix: reformation #28

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 28
 Nonlinear solution status: time= 0.34324
	stiffness updates             = 0
	right hand side evaluations   = 70
	stiffness matrix reformations = 28
	step from line search         = 0.156012
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.401215e-07    4.699908e-10    0.000000e+00 
	   energy              4.233504e-04    1.144880e-09    4.233504e-06 
	   displacement        9.883871e+01    2.601213e-04    3.044282e-04 

convergence summary
    number of iterations   : 28
    number of reformations : 28

------- converged at time : 0.34324


Data Record #1
===========================================================================
Step = 9
Time = 0.343239728
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(34%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: decreasing time step, dt = 0.0228181


===== beginning time step 10 : 0.366058 =====

Setting parameter "T0" to : 0.366058

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    3.416146e-04    0.000000e+00 
	   energy              3.187831e-04    1.853315e-04    3.187831e-06 
	   displacement        7.616588e+01    7.616588e+01    7.616588e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    4.442612e-08    0.000000e+00 
	   energy              3.187831e-04    1.118031e-05    3.187831e-06 
	   displacement        7.616588e+01    1.533722e+00    9.757465e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.554473
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    2.535360e-06    0.000000e+00 
	   energy              3.187831e-04    1.581066e-06    3.187831e-06 
	   displacement        7.616588e+01    5.616640e+00    1.490627e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    2.081551e-07    0.000000e+00 
	   energy              3.187831e-04    8.336264e-07    3.187831e-06 
	   displacement        7.616588e+01    1.871375e+00    1.839183e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    1.852118e-08    0.000000e+00 
	   energy              3.187831e-04    7.207386e-08    3.187831e-06 
	   displacement        7.616588e+01    4.714660e-01    2.027749e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    1.085432e-10    0.000000e+00 
	   energy              3.187831e-04    1.410547e-08    3.187831e-06 
	   displacement        7.616588e+01    6.781104e-03    2.049809e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    3.147047e-11    0.000000e+00 
	   energy              3.187831e-04    4.053803e-09    3.187831e-06 
	   displacement        7.616588e+01    3.576216e-04    2.054149e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.366058
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            7.313385e-07    6.759857e-13    0.000000e+00 
	   energy              3.187831e-04    1.183160e-10    3.187831e-06 
	   displacement        7.616588e+01    7.000585e-05    2.056017e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.366058


Data Record #1
===========================================================================
Step = 10
Time = 0.36605786
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(37%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0262545


===== beginning time step 11 : 0.392312 =====

Setting parameter "T0" to : 0.392312

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    4.532361e-04    0.000000e+00 
	   energy              3.917780e-04    2.629984e-04    3.917780e-06 
	   displacement        8.625666e+01    8.625666e+01    8.625666e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    5.978003e-08    0.000000e+00 
	   energy              3.917780e-04    1.323793e-05    3.917780e-06 
	   displacement        8.625666e+01    1.753226e+00    1.103625e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.490832
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    3.150726e-06    0.000000e+00 
	   energy              3.917780e-04    2.560599e-06    3.917780e-06 
	   displacement        8.625666e+01    6.025630e+00    1.668033e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    5.715092e-07    0.000000e+00 
	   energy              3.917780e-04    1.460587e-06    3.917780e-06 
	   displacement        8.625666e+01    2.947386e+00    2.135195e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    6.227140e-08    0.000000e+00 
	   energy              3.917780e-04    1.945078e-07    3.917780e-06 
	   displacement        8.625666e+01    9.067879e-01    2.419540e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 6
	step from line search         = 0.306549
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    2.968327e-08    0.000000e+00 
	   energy              3.917780e-04    6.327555e-08    3.917780e-06 
	   displacement        8.625666e+01    4.751076e-03    2.406400e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    2.409749e-10    0.000000e+00 
	   energy              3.917780e-04    1.061576e-08    3.917780e-06 
	   displacement        8.625666e+01    4.255701e-02    2.470462e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    2.466676e-11    0.000000e+00 
	   energy              3.917780e-04    5.367775e-09    3.917780e-06 
	   displacement        8.625666e+01    2.859079e-04    2.470553e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.392312
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.268877e-07    2.058527e-12    0.000000e+00 
	   energy              3.917780e-04    5.914363e-10    3.917780e-06 
	   displacement        8.625666e+01    6.011494e-05    2.470888e-04 

convergence summary
    number of iterations   : 9
    number of reformations : 9

------- converged at time : 0.392312


Data Record #1
===========================================================================
Step = 11
Time = 0.392312365
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(39%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0290036


===== beginning time step 12 : 0.421316 =====

Setting parameter "T0" to : 0.421316

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    5.217071e-04    0.000000e+00 
	   energy              4.542230e-04    3.026057e-04    4.542230e-06 
	   displacement        9.041227e+01    9.041227e+01    9.041227e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    7.522808e-08    0.000000e+00 
	   energy              4.542230e-04    1.524168e-05    4.542230e-06 
	   displacement        9.041227e+01    2.041883e+00    1.168128e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.448349
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    3.512125e-06    0.000000e+00 
	   energy              4.542230e-04    3.432152e-06    4.542230e-06 
	   displacement        9.041227e+01    6.111303e+00    1.750509e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    1.204413e-06    0.000000e+00 
	   energy              4.542230e-04    2.097121e-06    4.542230e-06 
	   displacement        9.041227e+01    4.268199e+00    2.331552e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    1.424097e-07    0.000000e+00 
	   energy              4.542230e-04    3.951443e-07    4.542230e-06 
	   displacement        9.041227e+01    1.494897e+00    2.715913e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 6
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    2.484073e-07    0.000000e+00 
	   energy              4.542230e-04    8.123335e-06    4.542230e-06 
	   displacement        9.041227e+01    1.499317e+00    3.115189e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 14
	stiffness matrix reformations = 7
	step from line search         = 0.010749
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    2.342413e-07    0.000000e+00 
	   energy              4.542230e-04    2.242309e-06    4.542230e-06 
	   displacement        9.041227e+01    1.007784e+00    2.794190e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 18
	stiffness matrix reformations = 8
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    4.080583e-07    0.000000e+00 
	   energy              4.542230e-04    1.498577e-05    4.542230e-06 
	   displacement        9.041227e+01    1.975486e+00    3.254591e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 21
	stiffness matrix reformations = 9
	step from line search         = 0.012741
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    4.973680e-07    0.000000e+00 
	   energy              4.542230e-04    3.431990e-06    4.542230e-06 
	   displacement        9.041227e+01    1.696392e+00    2.832355e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 25
	stiffness matrix reformations = 10
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    8.165808e-07    0.000000e+00 
	   energy              4.542230e-04    2.639701e-05    4.542230e-06 
	   displacement        9.041227e+01    3.036296e+00    3.406526e-04 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 28
	stiffness matrix reformations = 11
	step from line search         = 0.061436
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    1.100541e-06    0.000000e+00 
	   energy              4.542230e-04    5.892086e-06    4.542230e-06 
	   displacement        9.041227e+01    2.615216e+00    2.878675e-04 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 32
	stiffness matrix reformations = 12
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    2.575338e-06    0.000000e+00 
	   energy              4.542230e-04    6.788292e-05    4.542230e-06 
	   displacement        9.041227e+01    6.803290e+00    3.758053e-04 
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 34
	stiffness matrix reformations = 13
	step from line search         = 0.149237
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    4.886385e-06    0.000000e+00 
	   energy              4.542230e-04    2.833955e-06    4.542230e-06 
	   displacement        9.041227e+01    7.469323e+00    2.857225e-04 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 36
	stiffness matrix reformations = 14
	step from line search         = 0.434121
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    1.688969e-06    0.000000e+00 
	   energy              4.542230e-04    9.383056e-07    4.542230e-06 
	   displacement        9.041227e+01    2.092096e-01    2.720929e-04 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 37
	stiffness matrix reformations = 15
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    3.467414e-09    0.000000e+00 
	   energy              4.542230e-04    6.638532e-07    4.542230e-06 
	   displacement        9.041227e+01    8.477263e-02    2.696777e-04 
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 38
	stiffness matrix reformations = 16
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    3.622590e-09    0.000000e+00 
	   energy              4.542230e-04    1.373716e-07    4.542230e-06 
	   displacement        9.041227e+01    7.881317e-02    2.781567e-04 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 39
	stiffness matrix reformations = 17
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    4.230716e-09    0.000000e+00 
	   energy              4.542230e-04    6.234677e-08    4.542230e-06 
	   displacement        9.041227e+01    7.042694e-02    2.863575e-04 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 43
	stiffness matrix reformations = 18
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    1.301859e-07    0.000000e+00 
	   energy              4.542230e-04    8.430182e-06    4.542230e-06 
	   displacement        9.041227e+01    1.193649e+00    3.222214e-04 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 47
	stiffness matrix reformations = 19
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.691708e-07    2.405006e-01    0.000000e+00 
	   energy              4.542230e-04    4.158117e-01    4.542230e-06 
	   displacement        9.041227e+01    3.745191e+03    2.001826e-03 

 *************************************************************************
 *                               WARNING                                 *
 *                                                                       *
 * Problem is diverging. Stiffness matrix will now be reformed           *
 *                                                                       *
 *************************************************************************
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.421316
	stiffness updates             = 0
	right hand side evaluations   = 49
	stiffness matrix reformations = 20
	step from line search         = 0.408610
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.405006e-01    7.915277e-02    0.000000e+00 
	   energy              4.158117e-01    1.933848e-02    4.158117e-03 
	   displacement        9.041227e+01    4.009150e+02    3.495684e-03 
Reforming stiffness matrix: reformation #21

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 21

 *************************************************************************
 *                                ERROR                                  *
 *                                                                       *
 * Negative jacobian was detected.                                       *
 *                                                                       *
 *************************************************************************


------- failed to converge at time : 0.421316

Retrying time step. Retry attempt 1 of max 5


AUTO STEPPER: retry step, dt = 0.0241697


===== beginning time step 12 : 0.416482 =====

Setting parameter "T0" to : 0.416482

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.416482
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.764620e-07    3.383159e-04    0.000000e+00 
	   energy              3.409689e-04    1.712420e-04    3.409689e-06 
	   displacement        7.275077e+01    7.275077e+01    7.275077e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.416482
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.764620e-07    5.763797e-08    0.000000e+00 
	   energy              3.409689e-04    1.245091e-05    3.409689e-06 
	   displacement        7.275077e+01    1.789257e+00    9.510374e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.416482
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.549981
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.764620e-07    2.618866e-06    0.000000e+00 
	   energy              3.409689e-04    1.693845e-06    3.409689e-06 
	   displacement        7.275077e+01    5.377860e+00    1.447485e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.416482
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.764620e-07    2.345782e-07    0.000000e+00 
	   energy              3.409689e-04    9.059437e-07    3.409689e-06 
	   displacement        7.275077e+01    1.891517e+00    1.793178e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.416482
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.764620e-07    2.095537e-08    0.000000e+00 
	   energy              3.409689e-04    8.883847e-08    3.409689e-06 
	   displacement        7.275077e+01    4.755294e-01    1.979715e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.416482
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.764620e-07    6.019869e-11    0.000000e+00 
	   energy              3.409689e-04    5.842258e-09    3.409689e-06 
	   displacement        7.275077e+01    9.682938e-03    2.006548e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.416482
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            8.764620e-07    1.483420e-12    0.000000e+00 
	   energy              3.409689e-04    5.760039e-10    3.409689e-06 
	   displacement        7.275077e+01    1.011684e-04    2.008676e-04 

convergence summary
    number of iterations   : 7
    number of reformations : 7

------- converged at time : 0.416482


Data Record #1
===========================================================================
Step = 12
Time = 0.416482036
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(42%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0273357


===== beginning time step 13 : 0.443818 =====

Setting parameter "T0" to : 0.443818

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    4.361588e-04    0.000000e+00 
	   energy              4.121581e-04    2.359180e-04    4.121581e-06 
	   displacement        8.243465e+01    8.243465e+01    8.243465e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    5.138190e-08    0.000000e+00 
	   energy              4.121581e-04    1.435057e-05    4.121581e-06 
	   displacement        8.243465e+01    1.458296e+00    1.039918e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.511115
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    3.204398e-06    0.000000e+00 
	   energy              4.121581e-04    2.465949e-06    4.121581e-06 
	   displacement        8.243465e+01    5.655275e+00    1.570827e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    4.307744e-07    0.000000e+00 
	   energy              4.121581e-04    1.354130e-06    4.121581e-06 
	   displacement        8.243465e+01    2.420740e+00    1.979926e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    4.401499e-08    0.000000e+00 
	   energy              4.121581e-04    1.472245e-07    4.121581e-06 
	   displacement        8.243465e+01    6.498219e-01    2.209727e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    1.958452e-10    0.000000e+00 
	   energy              4.121581e-04    8.107933e-09    4.121581e-06 
	   displacement        8.243465e+01    2.528702e-02    2.255680e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    1.427743e-11    0.000000e+00 
	   energy              4.121581e-04    2.082857e-09    4.121581e-06 
	   displacement        8.243465e+01    3.823069e-04    2.260860e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.443818
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            9.723559e-07    1.305636e-12    0.000000e+00 
	   energy              4.121581e-04    5.583931e-11    4.121581e-06 
	   displacement        8.243465e+01    4.154040e-05    2.262521e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.443818


Data Record #1
===========================================================================
Step = 13
Time = 0.443817772
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(44%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0298686


===== beginning time step 14 : 0.473686 =====

Setting parameter "T0" to : 0.473686

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    4.647873e-04    0.000000e+00 
	   energy              4.545081e-04    2.510875e-04    4.545081e-06 
	   displacement        8.102007e+01    8.102007e+01    8.102007e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    7.935124e-08    0.000000e+00 
	   energy              4.545081e-04    1.748061e-05    4.545081e-06 
	   displacement        8.102007e+01    1.973746e+00    1.054243e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.480241
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    3.882847e-06    0.000000e+00 
	   energy              4.545081e-04    3.266391e-06    4.545081e-06 
	   displacement        8.102007e+01    6.106001e+00    1.610385e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    7.705647e-07    0.000000e+00 
	   energy              4.545081e-04    1.887546e-06    4.545081e-06 
	   displacement        8.102007e+01    3.282540e+00    2.095548e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    9.140066e-08    0.000000e+00 
	   energy              4.545081e-04    3.097790e-07    4.545081e-06 
	   displacement        8.102007e+01    9.340140e-01    2.379988e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 6
	step from line search         = 0.522157
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    2.247521e-08    0.000000e+00 
	   energy              4.545081e-04    3.129182e-08    4.545081e-06 
	   displacement        8.102007e+01    6.704323e-03    2.399532e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    2.359260e-10    0.000000e+00 
	   energy              4.545081e-04    1.316187e-08    4.545081e-06 
	   displacement        8.102007e+01    2.887243e-02    2.451934e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    1.702000e-11    0.000000e+00 
	   energy              4.545081e-04    3.447585e-10    4.545081e-06 
	   displacement        8.102007e+01    8.925969e-04    2.460268e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    1.488531e-11    0.000000e+00 
	   energy              4.545081e-04    2.758082e-09    4.545081e-06 
	   displacement        8.102007e+01    3.036412e-04    2.455549e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.473686
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 10
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.085769e-06    3.445295e-12    0.000000e+00 
	   energy              4.545081e-04    8.757281e-10    4.545081e-06 
	   displacement        8.102007e+01    5.849877e-05    2.457162e-04 

convergence summary
    number of iterations   : 10
    number of reformations : 10

------- converged at time : 0.473686


Data Record #1
===========================================================================
Step = 14
Time = 0.473686361
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(47%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0318949


===== beginning time step 15 : 0.505581 =====

Setting parameter "T0" to : 0.505581

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    5.041081e-04    0.000000e+00 
	   energy              5.094155e-04    2.626850e-04    5.094155e-06 
	   displacement        8.401341e+01    8.401341e+01    8.401341e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    8.692878e-08    0.000000e+00 
	   energy              5.094155e-04    1.891741e-05    5.094155e-06 
	   displacement        8.401341e+01    2.007269e+00    1.089692e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.463116
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    4.085506e-06    0.000000e+00 
	   energy              5.094155e-04    3.681691e-06    5.094155e-06 
	   displacement        8.401341e+01    5.921201e+00    1.644759e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    1.046291e-06    0.000000e+00 
	   energy              5.094155e-04    2.030553e-06    5.094155e-06 
	   displacement        8.401341e+01    3.655424e+00    2.164459e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    1.175901e-07    0.000000e+00 
	   energy              5.094155e-04    4.369013e-07    5.094155e-06 
	   displacement        8.401341e+01    1.034473e+00    2.468240e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 6
	step from line search         = 0.037648
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    1.091024e-07    0.000000e+00 
	   energy              5.094155e-04    6.659462e-08    5.094155e-06 
	   displacement        8.401341e+01    1.190892e-02    2.437650e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    1.758567e-09    0.000000e+00 
	   energy              5.094155e-04    1.536215e-09    5.094155e-06 
	   displacement        8.401341e+01    1.158467e-01    2.544186e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    1.820979e-11    0.000000e+00 
	   energy              5.094155e-04    5.348324e-09    5.094155e-06 
	   displacement        8.401341e+01    1.320195e-03    2.554314e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.505581
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.238386e-06    3.698602e-12    0.000000e+00 
	   energy              5.094155e-04    4.502043e-10    5.094155e-06 
	   displacement        8.401341e+01    5.915047e-05    2.555534e-04 

convergence summary
    number of iterations   : 9
    number of reformations : 9

------- converged at time : 0.505581


Data Record #1
===========================================================================
Step = 15
Time = 0.505581232
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(51%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0335159


===== beginning time step 16 : 0.539097 =====

Setting parameter "T0" to : 0.539097

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    4.943238e-04    0.000000e+00 
	   energy              5.369659e-04    2.454453e-04    5.369659e-06 
	   displacement        8.029945e+01    8.029945e+01    8.029945e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    1.015667e-07    0.000000e+00 
	   energy              5.369659e-04    2.161373e-05    5.369659e-06 
	   displacement        8.029945e+01    2.127713e+00    1.052220e-04 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.458397
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    4.380636e-06    0.000000e+00 
	   energy              5.369659e-04    4.063770e-06    5.369659e-06 
	   displacement        8.029945e+01    5.974452e+00    1.599918e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    1.169850e-06    0.000000e+00 
	   energy              5.369659e-04    2.576164e-06    5.369659e-06 
	   displacement        8.029945e+01    3.812406e+00    2.123034e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    1.714534e-07    0.000000e+00 
	   energy              5.369659e-04    6.976129e-07    5.369659e-06 
	   displacement        8.029945e+01    1.334206e+00    2.467328e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 6
	step from line search         = 0.518554
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    5.594835e-08    0.000000e+00 
	   energy              5.369659e-04    7.649663e-08    5.369659e-06 
	   displacement        8.029945e+01    1.216365e-01    2.576167e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 7
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    6.293841e-08    0.000000e+00 
	   energy              5.369659e-04    2.221633e-06    5.369659e-06 
	   displacement        8.029945e+01    3.918976e-01    2.771301e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 18
	stiffness matrix reformations = 8
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    4.127035e-07    0.000000e+00 
	   energy              5.369659e-04    1.800656e-05    5.369659e-06 
	   displacement        8.029945e+01    2.351528e+00    3.273580e-04 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 22
	stiffness matrix reformations = 9
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    1.493303e-05    0.000000e+00 
	   energy              5.369659e-04    2.253284e-04    5.369659e-06 
	   displacement        8.029945e+01    2.519375e+01    5.231143e-04 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 24
	stiffness matrix reformations = 10
	step from line search         = 0.032287
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    3.273282e-05    0.000000e+00 
	   energy              5.369659e-04    2.432885e-05    5.369659e-06 
	   displacement        8.029945e+01    1.993698e+01    3.711414e-04 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 29
	stiffness matrix reformations = 11
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    1.429012e-05    0.000000e+00 
	   energy              5.369659e-04    2.025302e-04    5.369659e-06 
	   displacement        8.029945e+01    7.180866e+00    4.559281e-04 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 32
	stiffness matrix reformations = 12
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.369402e-06    4.929209e-02    0.000000e+00 
	   energy              5.369659e-04    7.694825e-02    5.369659e-06 
	   displacement        8.029945e+01    2.162978e+03    4.219451e-03 

 *************************************************************************
 *                               WARNING                                 *
 *                                                                       *
 * Problem is diverging. Stiffness matrix will now be reformed           *
 *                                                                       *
 *************************************************************************
Reforming stiffness matrix: reformation #13

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 13
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 34
	stiffness matrix reformations = 13
	step from line search         = 0.266796
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            4.929209e-02    2.735738e-02    0.000000e+00 
	   energy              7.694825e-02    4.950902e-03    7.694825e-04 
	   displacement        8.029945e+01    1.846554e+02    4.148567e-03 
Reforming stiffness matrix: reformation #14

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 14
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 36
	stiffness matrix reformations = 14
	step from line search         = 0.549630
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            4.929209e-02    5.895070e-03    0.000000e+00 
	   energy              7.694825e-02    1.734517e-03    7.694825e-04 
	   displacement        8.029945e+01    1.968089e+02    4.981525e-03 
Reforming stiffness matrix: reformation #15

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 15
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 39
	stiffness matrix reformations = 15
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            4.929209e-02    2.808244e-01    0.000000e+00 
	   energy              7.694825e-02    3.691066e-01    7.694825e-04 
	   displacement        8.029945e+01    1.018876e+04    2.282949e-02 

 *************************************************************************
 *                               WARNING                                 *
 *                                                                       *
 * Problem is diverging. Stiffness matrix will now be reformed           *
 *                                                                       *
 *************************************************************************
Reforming stiffness matrix: reformation #16

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 16
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 41
	stiffness matrix reformations = 16
	step from line search         = 0.473129
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    3.630144e-02    0.000000e+00 
	   energy              3.691066e-01    1.535288e-02    3.691066e-03 
	   displacement        8.029945e+01    1.184604e+03    1.667650e-02 
Reforming stiffness matrix: reformation #17

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 17
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 42
	stiffness matrix reformations = 17
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    4.435646e-03    0.000000e+00 
	   energy              3.691066e-01    9.020009e-03    3.691066e-03 
	   displacement        8.029945e+01    3.417698e+02    1.744306e-02 
Reforming stiffness matrix: reformation #18

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 18
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 45
	stiffness matrix reformations = 18
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    3.673391e-02    0.000000e+00 
	   energy              3.691066e-01    5.470459e-02    3.691066e-03 
	   displacement        8.029945e+01    1.321596e+03    2.376493e-02 
Reforming stiffness matrix: reformation #19

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 19
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 46
	stiffness matrix reformations = 19
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    1.750518e-02    0.000000e+00 
	   energy              3.691066e-01    3.014333e-02    3.691066e-03 
	   displacement        8.029945e+01    1.351326e+03    1.979969e-02 
Reforming stiffness matrix: reformation #20

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 20
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 48
	stiffness matrix reformations = 20
	step from line search         = 0.200716
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    1.156769e-02    0.000000e+00 
	   energy              3.691066e-01    2.649959e-04    3.691066e-03 
	   displacement        8.029945e+01    1.890024e+02    2.326496e-02 
Reforming stiffness matrix: reformation #21

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 21
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 50
	stiffness matrix reformations = 21
	step from line search         = 0.415220
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    4.701935e-03    0.000000e+00 
	   energy              3.691066e-01    8.203118e-04    3.691066e-03 
	   displacement        8.029945e+01    2.549271e+02    2.772818e-02 
Reforming stiffness matrix: reformation #22

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 22
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 52
	stiffness matrix reformations = 22
	step from line search         = 0.164321
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    3.787733e-03    0.000000e+00 
	   energy              3.691066e-01    6.985165e-04    3.691066e-03 
	   displacement        8.029945e+01    1.040131e+02    2.626461e-02 
Reforming stiffness matrix: reformation #23

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 23
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 58
	stiffness matrix reformations = 23
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    3.443211e-03    0.000000e+00 
	   energy              3.691066e-01    8.356457e-03    3.691066e-03 
	   displacement        8.029945e+01    8.674775e+02    3.544086e-02 
Reforming stiffness matrix: reformation #24

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 24
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 60
	stiffness matrix reformations = 24
	step from line search         = 0.159269
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    2.893337e-03    0.000000e+00 
	   energy              3.691066e-01    1.240567e-03    3.691066e-03 
	   displacement        8.029945e+01    1.042807e+02    3.352680e-02 
Reforming stiffness matrix: reformation #25

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 25
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 66
	stiffness matrix reformations = 25
	step from line search         = 0.044198
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    2.695158e-03    0.000000e+00 
	   energy              3.691066e-01    9.973640e-04    3.691066e-03 
	   displacement        8.029945e+01    1.446190e+01    3.478553e-02 
Reforming stiffness matrix: reformation #26

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 26
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 71
	stiffness matrix reformations = 26
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    1.312760e-02    0.000000e+00 
	   energy              3.691066e-01    2.574080e-02    3.691066e-03 
	   displacement        8.029945e+01    2.282594e+03    5.316560e-02 
Reforming stiffness matrix: reformation #27

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 27
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 73
	stiffness matrix reformations = 27
	step from line search         = 0.564019
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    4.926378e-03    0.000000e+00 
	   energy              3.691066e-01    5.530018e-03    3.691066e-03 
	   displacement        8.029945e+01    6.771398e+02    4.613183e-02 
Reforming stiffness matrix: reformation #28

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 28
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 79
	stiffness matrix reformations = 28
	step from line search         = 0.011841
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    4.825201e-03    0.000000e+00 
	   energy              3.691066e-01    5.531700e-04    3.691066e-03 
	   displacement        8.029945e+01    1.848765e+00    4.560322e-02 
Reforming stiffness matrix: reformation #29

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 29
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 85
	stiffness matrix reformations = 29
	step from line search         = 0.500000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    2.107736e-02    0.000000e+00 
	   energy              3.691066e-01    4.399888e-02    3.691066e-03 
	   displacement        8.029945e+01    2.506533e+03    2.864933e-02 
Reforming stiffness matrix: reformation #30

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 30
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 86
	stiffness matrix reformations = 30
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    1.623955e-02    0.000000e+00 
	   energy              3.691066e-01    7.767780e-02    3.691066e-03 
	   displacement        8.029945e+01    2.640082e+03    1.542832e-02 
Reforming stiffness matrix: reformation #31

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 31
 Nonlinear solution status: time= 0.539097
	stiffness updates             = 0
	right hand side evaluations   = 87
	stiffness matrix reformations = 31
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.808244e-01    2.676913e-02    0.000000e+00 
	   energy              3.691066e-01    1.307392e-01    3.691066e-03 
	   displacement        8.029945e+01    6.225527e+02    1.225189e-02 
Reforming stiffness matrix: reformation #32

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 32

 *************************************************************************
 *                                ERROR                                  *
 *                                                                       *
 * Negative jacobian was detected.                                       *
 *                                                                       *
 *************************************************************************


------- failed to converge at time : 0.539097

Retrying time step. Retry attempt 1 of max 5


AUTO STEPPER: retry step, dt = 0.0279299


===== beginning time step 16 : 0.533511 =====

Setting parameter "T0" to : 0.533511

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    3.234664e-04    0.000000e+00 
	   energy              4.068749e-04    1.273378e-04    4.068749e-06 
	   displacement        6.461771e+01    6.461771e+01    6.461771e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    7.794949e-08    0.000000e+00 
	   energy              4.068749e-04    1.774922e-05    4.068749e-06 
	   displacement        6.461771e+01    1.867756e+00    8.578412e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.563057
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    3.367339e-06    0.000000e+00 
	   energy              4.068749e-04    2.059304e-06    4.068749e-06 
	   displacement        6.461771e+01    5.369621e+00    1.330984e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    2.267621e-07    0.000000e+00 
	   energy              4.068749e-04    1.075952e-06    4.068749e-06 
	   displacement        6.461771e+01    1.709001e+00    1.644883e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    3.150278e-08    0.000000e+00 
	   energy              4.068749e-04    9.890346e-08    4.068749e-06 
	   displacement        6.461771e+01    4.988579e-01    1.827246e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    5.673305e-11    0.000000e+00 
	   energy              4.068749e-04    7.933673e-09    4.068749e-06 
	   displacement        6.461771e+01    7.745564e-03    1.849726e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    4.613480e-12    0.000000e+00 
	   energy              4.068749e-04    1.478001e-09    4.068749e-06 
	   displacement        6.461771e+01    2.679491e-04    1.853640e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.533511
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.243986e-06    7.619923e-14    0.000000e+00 
	   energy              4.068749e-04    3.190608e-11    4.068749e-06 
	   displacement        6.461771e+01    7.835552e-06    1.853795e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.533511


Data Record #1
===========================================================================
Step = 16
Time = 0.533511146
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(53%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0303439


===== beginning time step 17 : 0.563855 =====

Setting parameter "T0" to : 0.563855

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    3.732564e-04    0.000000e+00 
	   energy              4.641272e-04    1.511359e-04    4.641272e-06 
	   displacement        6.956683e+01    6.956683e+01    6.956683e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    6.904989e-08    0.000000e+00 
	   energy              4.641272e-04    1.662432e-05    4.641272e-06 
	   displacement        6.956683e+01    1.759226e+00    9.085370e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.519945
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    3.250033e-06    0.000000e+00 
	   energy              4.641272e-04    2.368360e-06    4.641272e-06 
	   displacement        6.956683e+01    4.963615e+00    1.372120e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    4.213717e-07    0.000000e+00 
	   energy              4.641272e-04    1.369663e-06    4.641272e-06 
	   displacement        6.956683e+01    2.133757e+00    1.730428e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    4.531500e-08    0.000000e+00 
	   energy              4.641272e-04    1.623479e-07    4.641272e-06 
	   displacement        6.956683e+01    5.876816e-01    1.934057e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    1.592559e-10    0.000000e+00 
	   energy              4.641272e-04    1.414984e-08    4.641272e-06 
	   displacement        6.956683e+01    1.874804e-02    1.969890e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    5.514003e-12    0.000000e+00 
	   energy              4.641272e-04    1.162272e-09    4.641272e-06 
	   displacement        6.956683e+01    2.629229e-04    1.973578e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.563855
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.300806e-06    7.577616e-13    0.000000e+00 
	   energy              4.641272e-04    1.880533e-11    4.641272e-06 
	   displacement        6.956683e+01    3.714562e-05    1.974984e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.563855


Data Record #1
===========================================================================
Step = 17
Time = 0.563855077
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(56%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0322751


===== beginning time step 18 : 0.59613 =====

Setting parameter "T0" to : 0.59613

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    3.827972e-04    0.000000e+00 
	   energy              4.975987e-04    1.492223e-04    4.975987e-06 
	   displacement        6.849122e+01    6.849122e+01    6.849122e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    8.255581e-08    0.000000e+00 
	   energy              4.975987e-04    1.878189e-05    4.975987e-06 
	   displacement        6.849122e+01    1.863579e+00    9.007307e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.514488
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    3.642365e-06    0.000000e+00 
	   energy              4.975987e-04    2.726920e-06    4.975987e-06 
	   displacement        6.849122e+01    5.067762e+00    1.367623e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    4.770995e-07    0.000000e+00 
	   energy              4.975987e-04    1.484349e-06    4.975987e-06 
	   displacement        6.849122e+01    2.213133e+00    1.732069e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    5.424857e-08    0.000000e+00 
	   energy              4.975987e-04    1.797767e-07    4.975987e-06 
	   displacement        6.849122e+01    5.825440e-01    1.934475e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    1.959410e-10    0.000000e+00 
	   energy              4.975987e-04    1.298140e-08    4.975987e-06 
	   displacement        6.849122e+01    2.178470e-02    1.973569e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    1.182906e-11    0.000000e+00 
	   energy              4.975987e-04    3.334150e-09    4.975987e-06 
	   displacement        6.849122e+01    1.080372e-03    1.981871e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.59613
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.397386e-06    2.875325e-13    0.000000e+00 
	   energy              4.975987e-04    1.347141e-10    4.975987e-06 
	   displacement        6.849122e+01    1.556004e-05    1.981716e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.59613


Data Record #1
===========================================================================
Step = 18
Time = 0.596130222
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(60%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0338201


===== beginning time step 19 : 0.62995 =====

Setting parameter "T0" to : 0.62995

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    3.653080e-04    0.000000e+00 
	   energy              5.196026e-04    1.270437e-04    5.196026e-06 
	   displacement        6.442192e+01    6.442192e+01    6.442192e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    1.146137e-07    0.000000e+00 
	   energy              5.196026e-04    2.196981e-05    5.196026e-06 
	   displacement        6.442192e+01    2.126397e+00    8.656422e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.523970
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    4.128873e-06    0.000000e+00 
	   energy              5.196026e-04    2.939747e-06    5.196026e-06 
	   displacement        6.442192e+01    5.201547e+00    1.330167e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    4.566127e-07    0.000000e+00 
	   energy              5.196026e-04    1.693397e-06    5.196026e-06 
	   displacement        6.442192e+01    2.132800e+00    1.682075e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    6.972342e-08    0.000000e+00 
	   energy              5.196026e-04    2.107909e-07    5.196026e-06 
	   displacement        6.442192e+01    6.540407e-01    1.893807e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    2.810687e-10    0.000000e+00 
	   energy              5.196026e-04    2.753090e-08    5.196026e-06 
	   displacement        6.442192e+01    2.026996e-02    1.930546e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    3.024394e-11    0.000000e+00 
	   energy              5.196026e-04    5.218634e-09    5.196026e-06 
	   displacement        6.442192e+01    1.228808e-03    1.939579e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.62995
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.514636e-06    4.869516e-13    0.000000e+00 
	   energy              5.196026e-04    6.454120e-11    5.196026e-06 
	   displacement        6.442192e+01    1.608125e-05    1.938896e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.62995


Data Record #1
===========================================================================
Step = 19
Time = 0.629950338
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(63%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0350561


===== beginning time step 20 : 0.665006 =====

Setting parameter "T0" to : 0.665006

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    3.673631e-04    0.000000e+00 
	   energy              5.491526e-04    1.134669e-04    5.491526e-06 
	   displacement        6.424488e+01    6.424488e+01    6.424488e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    1.246000e-07    0.000000e+00 
	   energy              5.491526e-04    2.355257e-05    5.491526e-06 
	   displacement        6.424488e+01    2.101937e+00    8.621084e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.535725
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    4.528155e-06    0.000000e+00 
	   energy              5.491526e-04    2.980361e-06    5.491526e-06 
	   displacement        6.424488e+01    5.279940e+00    1.330262e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    3.744537e-07    0.000000e+00 
	   energy              5.491526e-04    1.652998e-06    5.491526e-06 
	   displacement        6.424488e+01    1.831476e+00    1.655122e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    6.976165e-08    0.000000e+00 
	   energy              5.491526e-04    1.765514e-07    5.491526e-06 
	   displacement        6.424488e+01    6.145185e-01    1.858620e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    1.896727e-10    0.000000e+00 
	   energy              5.491526e-04    2.098649e-08    5.491526e-06 
	   displacement        6.424488e+01    1.425242e-02    1.889001e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    1.676944e-11    0.000000e+00 
	   energy              5.491526e-04    5.245068e-09    5.491526e-06 
	   displacement        6.424488e+01    1.055954e-03    1.897323e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.665006
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.648843e-06    4.920009e-13    0.000000e+00 
	   energy              5.491526e-04    1.726710e-10    5.491526e-06 
	   displacement        6.424488e+01    3.638009e-05    1.897184e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.665006


Data Record #1
===========================================================================
Step = 20
Time = 0.665006431
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(67%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0360449


===== beginning time step 21 : 0.701051 =====

Setting parameter "T0" to : 0.701051

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    3.493808e-04    0.000000e+00 
	   energy              5.693414e-04    8.566019e-05    5.693414e-06 
	   displacement        6.163256e+01    6.163256e+01    6.163256e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    1.344085e-07    0.000000e+00 
	   energy              5.693414e-04    2.523689e-05    5.693414e-06 
	   displacement        6.163256e+01    2.122916e+00    8.317906e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.556907
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    4.807868e-06    0.000000e+00 
	   energy              5.693414e-04    2.929488e-06    5.693414e-06 
	   displacement        6.163256e+01    5.230448e+00    1.290102e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    3.003894e-07    0.000000e+00 
	   energy              5.693414e-04    1.379633e-06    5.693414e-06 
	   displacement        6.163256e+01    1.628439e+00    1.591477e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    5.851241e-08    0.000000e+00 
	   energy              5.693414e-04    1.060311e-07    5.693414e-06 
	   displacement        6.163256e+01    5.045987e-01    1.770438e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    7.450179e-11    0.000000e+00 
	   energy              5.693414e-04    6.297847e-10    5.693414e-06 
	   displacement        6.163256e+01    1.232660e-02    1.799106e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    9.759792e-12    0.000000e+00 
	   energy              5.693414e-04    1.587076e-09    5.693414e-06 
	   displacement        6.163256e+01    4.895299e-04    1.804810e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.701051
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.780493e-06    9.016472e-12    0.000000e+00 
	   energy              5.693414e-04    6.031922e-10    5.693414e-06 
	   displacement        6.163256e+01    1.640697e-05    1.803971e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.701051


Data Record #1
===========================================================================
Step = 21
Time = 0.701051305
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(70%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0368359


===== beginning time step 22 : 0.737887 =====

Setting parameter "T0" to : 0.737887

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    3.114812e-04    0.000000e+00 
	   energy              5.749954e-04    4.737766e-05    5.749954e-06 
	   displacement        5.636345e+01    5.636345e+01    5.636345e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    1.515682e-07    0.000000e+00 
	   energy              5.749954e-04    2.722976e-05    5.749954e-06 
	   displacement        5.636345e+01    2.351183e+00    7.790086e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.567029
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    4.793422e-06    0.000000e+00 
	   energy              5.749954e-04    2.760572e-06    5.749954e-06 
	   displacement        5.636345e+01    5.113402e+00    1.217724e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    2.641961e-07    0.000000e+00 
	   energy              5.749954e-04    1.418417e-06    5.749954e-06 
	   displacement        5.636345e+01    1.478964e+00    1.496243e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    5.587142e-08    0.000000e+00 
	   energy              5.749954e-04    1.249647e-07    5.749954e-06 
	   displacement        5.636345e+01    4.991666e-01    1.669467e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    1.665640e-10    0.000000e+00 
	   energy              5.749954e-04    1.770713e-08    5.749954e-06 
	   displacement        5.636345e+01    6.745041e-03    1.688617e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    4.180946e-11    0.000000e+00 
	   energy              5.749954e-04    5.178928e-09    5.749954e-06 
	   displacement        5.636345e+01    6.044477e-04    1.694125e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.737887
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.904442e-06    2.516742e-12    0.000000e+00 
	   energy              5.749954e-04    1.050066e-10    5.749954e-06 
	   displacement        5.636345e+01    8.345112e-05    1.695702e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.737887


Data Record #1
===========================================================================
Step = 22
Time = 0.737887205
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(74%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0374687


===== beginning time step 23 : 0.775356 =====

Setting parameter "T0" to : 0.775356

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    2.907740e-04    0.000000e+00 
	   energy              5.928616e-04    1.480426e-05    5.928616e-06 
	   displacement        5.408782e+01    5.408782e+01    5.408782e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    1.434053e-07    0.000000e+00 
	   energy              5.928616e-04    2.681476e-05    5.928616e-06 
	   displacement        5.408782e+01    2.330459e+00    7.511641e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.583229
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    4.683291e-06    0.000000e+00 
	   energy              5.928616e-04    2.568656e-06    5.928616e-06 
	   displacement        5.408782e+01    4.907146e+00    1.173005e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    2.085474e-07    0.000000e+00 
	   energy              5.928616e-04    1.202930e-06    5.928616e-06 
	   displacement        5.408782e+01    1.261113e+00    1.424103e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    4.031339e-08    0.000000e+00 
	   energy              5.928616e-04    7.030219e-08    5.928616e-06 
	   displacement        5.408782e+01    3.855490e-01    1.571458e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    4.001396e-11    0.000000e+00 
	   energy              5.928616e-04    1.155607e-09    5.928616e-06 
	   displacement        5.408782e+01    6.447990e-03    1.590803e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 9
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    1.558823e-11    0.000000e+00 
	   energy              5.928616e-04    1.561954e-09    5.928616e-06 
	   displacement        5.408782e+01    2.822336e-04    1.594852e-04 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.775356
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 8
	step from line search         = 0.634034
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.030644e-06    7.609049e-12    0.000000e+00 
	   energy              5.928616e-04    3.449693e-10    5.928616e-06 
	   displacement        5.408782e+01    1.254207e-05    1.594020e-04 

convergence summary
    number of iterations   : 8
    number of reformations : 8

------- converged at time : 0.775356


Data Record #1
===========================================================================
Step = 23
Time = 0.775355924
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(78%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.037975


===== beginning time step 24 : 0.813331 =====

Setting parameter "T0" to : 0.813331

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.813331
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.138542e-06    2.578008e-04    0.000000e+00 
	   energy              5.916484e-04    1.622667e-05    5.916484e-06 
	   displacement        4.971059e+01    4.971059e+01    4.971059e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.813331
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.138542e-06    1.526296e-07    0.000000e+00 
	   energy              5.916484e-04    2.974615e-05    5.916484e-06 
	   displacement        4.971059e+01    2.241730e+00    6.943933e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.813331
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 3
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.138542e-06    2.810054e-05    0.000000e+00 
	   energy              5.916484e-04    2.218725e-05    5.916484e-06 
	   displacement        4.971059e+01    1.190021e+01    1.372933e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.813331
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.138542e-06    6.714825e-10    0.000000e+00 
	   energy              5.916484e-04    7.344356e-08    5.916484e-06 
	   displacement        4.971059e+01    2.387612e-02    1.402410e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.813331
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.138542e-06    2.758544e-10    0.000000e+00 
	   energy              5.916484e-04    5.521296e-08    5.916484e-06 
	   displacement        4.971059e+01    8.489854e-03    1.420247e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.813331
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.138542e-06    1.288191e-11    0.000000e+00 
	   energy              5.916484e-04    5.333399e-09    5.916484e-06 
	   displacement        4.971059e+01    4.639343e-04    1.423687e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.813331
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.138542e-06    4.005075e-13    0.000000e+00 
	   energy              5.916484e-04    2.734176e-11    5.916484e-06 
	   displacement        4.971059e+01    3.570441e-05    1.424353e-04 

convergence summary
    number of iterations   : 7
    number of reformations : 7

------- converged at time : 0.813331


Data Record #1
===========================================================================
Step = 24
Time = 0.8133309
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(81%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.03838


===== beginning time step 25 : 0.851711 =====

Setting parameter "T0" to : 0.851711

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.851711
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.207615e-06    2.109871e-04    0.000000e+00 
	   energy              5.750335e-04    4.859961e-05    5.750335e-06 
	   displacement        4.312459e+01    4.312459e+01    4.312459e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.851711
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.207615e-06    1.711446e-07    0.000000e+00 
	   energy              5.750335e-04    3.183726e-05    5.750335e-06 
	   displacement        4.312459e+01    2.153215e+00    6.108119e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.851711
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 3
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.207615e-06    1.874698e-05    0.000000e+00 
	   energy              5.750335e-04    1.524254e-05    5.750335e-06 
	   displacement        4.312459e+01    9.400742e+00    1.172613e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.851711
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.207615e-06    4.520348e-10    0.000000e+00 
	   energy              5.750335e-04    3.392467e-08    5.750335e-06 
	   displacement        4.312459e+01    2.785196e-02    1.193795e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.851711
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.207615e-06    3.767746e-10    0.000000e+00 
	   energy              5.750335e-04    5.557423e-08    5.750335e-06 
	   displacement        4.312459e+01    6.191204e-03    1.205301e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.851711
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.207615e-06    7.851521e-11    0.000000e+00 
	   energy              5.750335e-04    1.137671e-08    5.750335e-06 
	   displacement        4.312459e+01    8.250237e-04    1.210681e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.851711
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.207615e-06    9.639037e-13    0.000000e+00 
	   energy              5.750335e-04    2.422186e-10    5.750335e-06 
	   displacement        4.312459e+01    5.424873e-05    1.210122e-04 

convergence summary
    number of iterations   : 7
    number of reformations : 7

------- converged at time : 0.851711


Data Record #1
===========================================================================
Step = 25
Time = 0.85171088
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(85%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.038704


===== beginning time step 26 : 0.890415 =====

Setting parameter "T0" to : 0.890415

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.890415
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.225977e-06    1.649819e-04    0.000000e+00 
	   energy              5.600323e-04    8.206448e-05    5.600323e-06 
	   displacement        3.664136e+01    3.664136e+01    3.664136e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.890415
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.225977e-06    1.475749e-07    0.000000e+00 
	   energy              5.600323e-04    3.212733e-05    5.600323e-06 
	   displacement        3.664136e+01    1.818134e+00    5.192644e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.890415
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 3
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.225977e-06    1.337258e-05    0.000000e+00 
	   energy              5.600323e-04    1.103524e-05    5.600323e-06 
	   displacement        3.664136e+01    8.150280e+00    1.000070e-04 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.890415
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.225977e-06    5.216726e-10    0.000000e+00 
	   energy              5.600323e-04    3.119866e-08    5.600323e-06 
	   displacement        3.664136e+01    3.010410e-02    1.017800e-04 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.890415
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.225977e-06    2.640131e-10    0.000000e+00 
	   energy              5.600323e-04    5.333543e-08    5.600323e-06 
	   displacement        3.664136e+01    5.730565e-03    1.019481e-04 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.890415
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.225977e-06    4.192397e-11    0.000000e+00 
	   energy              5.600323e-04    1.420942e-08    5.600323e-06 
	   displacement        3.664136e+01    1.050735e-03    1.024698e-04 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.890415
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.225977e-06    1.279160e-12    0.000000e+00 
	   energy              5.600323e-04    4.785028e-10    5.600323e-06 
	   displacement        3.664136e+01    7.447954e-05    1.024462e-04 

convergence summary
    number of iterations   : 7
    number of reformations : 7

------- converged at time : 0.890415


Data Record #1
===========================================================================
Step = 26
Time = 0.890414865
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(89%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0389632


===== beginning time step 27 : 0.929378 =====

Setting parameter "T0" to : 0.929378

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.341811e-04    0.000000e+00 
	   energy              5.514568e-04    1.083013e-04    5.514568e-06 
	   displacement        3.230511e+01    3.230511e+01    3.230511e-05 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.262824e-07    0.000000e+00 
	   energy              5.514568e-04    2.894558e-05    5.514568e-06 
	   displacement        3.230511e+01    1.814575e+00    4.663525e-05 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 3
	step from line search         = 0.174961
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.245565e-07    0.000000e+00 
	   energy              5.514568e-04    2.812204e-06    5.514568e-06 
	   displacement        3.230511e+01    2.052545e-01    5.282978e-05 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.213147e-08    0.000000e+00 
	   energy              5.514568e-04    1.516483e-06    5.514568e-06 
	   displacement        3.230511e+01    1.699114e-01    5.811241e-05 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 5
	step from line search         = 0.493986
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    9.015741e-09    0.000000e+00 
	   energy              5.514568e-04    4.053743e-07    5.514568e-06 
	   displacement        3.230511e+01    2.072575e-01    5.440022e-05 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 10
	stiffness matrix reformations = 6
	step from line search         = 0.604070
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.044602e-08    0.000000e+00 
	   energy              5.514568e-04    2.377150e-07    5.514568e-06 
	   displacement        3.230511e+01    2.345810e-01    5.678863e-05 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 11
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.555105e-09    0.000000e+00 
	   energy              5.514568e-04    9.833894e-08    5.514568e-06 
	   displacement        3.230511e+01    9.362181e-02    5.617281e-05 
Reforming stiffness matrix: reformation #8

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 8
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 12
	stiffness matrix reformations = 8
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.874189e-11    0.000000e+00 
	   energy              5.514568e-04    1.056121e-08    5.514568e-06 
	   displacement        3.230511e+01    3.502544e-03    5.639948e-05 
Reforming stiffness matrix: reformation #9

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 9
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 13
	stiffness matrix reformations = 9
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    5.320178e-13    0.000000e+00 
	   energy              5.514568e-04    2.548012e-10    5.514568e-06 
	   displacement        3.230511e+01    8.601178e-05    5.641926e-05 
Reforming stiffness matrix: reformation #10

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 10
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 14
	stiffness matrix reformations = 10
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.807867e-13    0.000000e+00 
	   energy              5.514568e-04    1.143394e-10    5.514568e-06 
	   displacement        3.230511e+01    6.038682e-05    5.635319e-05 
Reforming stiffness matrix: reformation #11

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 11
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 15
	stiffness matrix reformations = 11
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    1.904495e-13    0.000000e+00 
	   energy              5.514568e-04    1.674466e-10    5.514568e-06 
	   displacement        3.230511e+01    6.193720e-05    5.640454e-05 
Reforming stiffness matrix: reformation #12

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 12
 Nonlinear solution status: time= 0.929378
	stiffness updates             = 0
	right hand side evaluations   = 16
	stiffness matrix reformations = 12
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.204500e-06    7.674309e-14    0.000000e+00 
	   energy              5.514568e-04    7.165609e-11    5.514568e-06 
	   displacement        3.230511e+01    2.450361e-05    5.637634e-05 

convergence summary
    number of iterations   : 12
    number of reformations : 12

------- converged at time : 0.929378


Data Record #1
===========================================================================
Step = 27
Time = 0.929378052
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(93%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0391706


===== beginning time step 28 : 0.968549 =====

Setting parameter "T0" to : 0.968549

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 0.968549
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.158777e-06    1.887127e-06    0.000000e+00 
	   energy              4.691737e-04    1.879320e-04    4.691737e-06 
	   displacement        3.053892e+00    3.053892e+00    3.053892e-06 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 0.968549
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.158777e-06    3.674933e-08    0.000000e+00 
	   energy              4.691737e-04    1.911673e-05    4.691737e-06 
	   displacement        3.053892e+00    2.436585e-01    4.214305e-06 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 0.968549
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 3
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.158777e-06    4.950945e-09    0.000000e+00 
	   energy              4.691737e-04    2.410757e-07    4.691737e-06 
	   displacement        3.053892e+00    3.591484e-02    4.888166e-06 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 0.968549
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.158777e-06    1.578476e-10    0.000000e+00 
	   energy              4.691737e-04    2.007572e-08    4.691737e-06 
	   displacement        3.053892e+00    1.659374e-03    4.876836e-06 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 0.968549
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.158777e-06    5.574811e-11    0.000000e+00 
	   energy              4.691737e-04    1.556137e-08    4.691737e-06 
	   displacement        3.053892e+00    5.398200e-04    4.814262e-06 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 0.968549
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.158777e-06    3.779731e-12    0.000000e+00 
	   energy              4.691737e-04    1.579465e-09    4.691737e-06 
	   displacement        3.053892e+00    6.780236e-05    4.837508e-06 
Reforming stiffness matrix: reformation #7

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 7
 Nonlinear solution status: time= 0.968549
	stiffness updates             = 0
	right hand side evaluations   = 8
	stiffness matrix reformations = 7
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            2.158777e-06    6.493105e-14    0.000000e+00 
	   energy              4.691737e-04    3.763470e-12    4.691737e-06 
	   displacement        3.053892e+00    2.817250e-06    4.835241e-06 

convergence summary
    number of iterations   : 7
    number of reformations : 7

------- converged at time : 0.968549


Data Record #1
===========================================================================
Step = 28
Time = 0.968548602
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(97%) tempModel.feb - FEBio 3.1.0  
AUTO STEPPER: increasing time step, dt = 0.0393364

MUST POINT CONTROLLER: adjusting time step. dt = 0.0314514


===== beginning time step 29 : 1 =====

Setting parameter "T0" to : 1

Reforming stiffness matrix: reformation #1

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 1
 Nonlinear solution status: time= 1
	stiffness updates             = 0
	right hand side evaluations   = 2
	stiffness matrix reformations = 1
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.844594e-06    1.723152e-06    0.000000e+00 
	   energy              3.415274e-04    1.695269e-04    3.415274e-06 
	   displacement        1.832702e+00    1.832702e+00    1.832702e-06 
Reforming stiffness matrix: reformation #2

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 2
 Nonlinear solution status: time= 1
	stiffness updates             = 0
	right hand side evaluations   = 3
	stiffness matrix reformations = 2
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.844594e-06    2.155613e-08    0.000000e+00 
	   energy              3.415274e-04    1.427444e-05    3.415274e-06 
	   displacement        1.832702e+00    2.061393e-01    2.881647e-06 
Reforming stiffness matrix: reformation #3

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 3
 Nonlinear solution status: time= 1
	stiffness updates             = 0
	right hand side evaluations   = 4
	stiffness matrix reformations = 3
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.844594e-06    1.347725e-09    0.000000e+00 
	   energy              3.415274e-04    1.131912e-08    3.415274e-06 
	   displacement        1.832702e+00    1.807616e-02    3.256817e-06 
Reforming stiffness matrix: reformation #4

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 4
 Nonlinear solution status: time= 1
	stiffness updates             = 0
	right hand side evaluations   = 5
	stiffness matrix reformations = 4
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.844594e-06    9.233353e-12    0.000000e+00 
	   energy              3.415274e-04    3.911309e-09    3.415274e-06 
	   displacement        1.832702e+00    5.494812e-04    3.243939e-06 
Reforming stiffness matrix: reformation #5

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 5
 Nonlinear solution status: time= 1
	stiffness updates             = 0
	right hand side evaluations   = 6
	stiffness matrix reformations = 5
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.844594e-06    9.008560e-13    0.000000e+00 
	   energy              3.415274e-04    3.041587e-10    3.415274e-06 
	   displacement        1.832702e+00    1.587480e-05    3.234027e-06 
Reforming stiffness matrix: reformation #6

===== reforming stiffness matrix:
	Nr of equations ........................... : 3336
	Nr of nonzeroes in stiffness matrix ....... : 63084
 6
 Nonlinear solution status: time= 1
	stiffness updates             = 0
	right hand side evaluations   = 7
	stiffness matrix reformations = 6
	step from line search         = 1.000000
	convergence norms :     INITIAL         CURRENT         REQUIRED
	   residual            1.844594e-06    1.272191e-14    0.000000e+00 
	   energy              3.415274e-04    6.619259e-12    3.415274e-06 
	   displacement        1.832702e+00    9.371147e-07    3.235763e-06 

convergence summary
    number of iterations   : 6
    number of reformations : 6

------- converged at time : 1


Data Record #1
===========================================================================
Step = 29
Time = 1
Data = ux;uy;uz
File = /mnt/data/MATLAB/GIBBON/data/temp/tempModel_disp_out.txt
 ]0;(100%) tempModel.feb - FEBio 3.1.0  

 N O N L I N E A R   I T E R A T I O N   I N F O R M A T I O N

	Number of time steps completed .................... : 29

	Total number of equilibrium iterations ............ : 333

	Average number of equilibrium iterations .......... : 11.4828

	Total number of right hand evaluations ............ : 541

	Total number of stiffness reformations ............ : 333


 L I N E A R   S O L V E R   S T A T S

	Total calls to linear solver ........ : 426

	Avg iterations per solve ............ : 1

	Time in linear solver: 0:00:08

 ]0;(100%) tempModel.feb - FEBio 3.1.0  
 Elapsed time : 0:00:35


 N O R M A L   T E R M I N A T I O N

 * Log file found.                                     18-Dec-2020 14:44:20
# Parsing log file...                                  18-Dec-2020 14:44:20
    number of iterations   : 13                        18-Dec-2020 14:44:21
    number of reformations : 13                        18-Dec-2020 14:44:21
------- converged at time : 0.04                       18-Dec-2020 14:44:21
    number of iterations   : 11                        18-Dec-2020 14:44:21
    number of reformations : 11                        18-Dec-2020 14:44:21
------- converged at time : 0.08                       18-Dec-2020 14:44:21
    number of iterations   : 14                        18-Dec-2020 14:44:21
    number of reformations : 14                        18-Dec-2020 14:44:21
------- converged at time : 0.12                       18-Dec-2020 14:44:21
    number of iterations   : 16                        18-Dec-2020 14:44:21
    number of reformations : 16                        18-Dec-2020 14:44:21
------- converged at time : 0.16                       18-Dec-2020 14:44:21
    number of iterations   : 20                        18-Dec-2020 14:44:21
    number of reformations : 20                        18-Dec-2020 14:44:21
------- converged at time : 0.2                        18-Dec-2020 14:44:21
    number of iterations   : 22                        18-Dec-2020 14:44:21
    number of reformations : 22                        18-Dec-2020 14:44:21
------- converged at time : 0.24                       18-Dec-2020 14:44:21
    number of iterations   : 20                        18-Dec-2020 14:44:21
    number of reformations : 20                        18-Dec-2020 14:44:21
------- converged at time : 0.278157                   18-Dec-2020 14:44:21
    number of iterations   : 28                        18-Dec-2020 14:44:21
    number of reformations : 28                        18-Dec-2020 14:44:21
------- converged at time : 0.316314                   18-Dec-2020 14:44:21
    number of iterations   : 28                        18-Dec-2020 14:44:21
    number of reformations : 28                        18-Dec-2020 14:44:21
------- converged at time : 0.34324                    18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.366058                   18-Dec-2020 14:44:21
    number of iterations   : 9                         18-Dec-2020 14:44:21
    number of reformations : 9                         18-Dec-2020 14:44:21
------- converged at time : 0.392312                   18-Dec-2020 14:44:21
    number of iterations   : 7                         18-Dec-2020 14:44:21
    number of reformations : 7                         18-Dec-2020 14:44:21
------- converged at time : 0.416482                   18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.443818                   18-Dec-2020 14:44:21
    number of iterations   : 10                        18-Dec-2020 14:44:21
    number of reformations : 10                        18-Dec-2020 14:44:21
------- converged at time : 0.473686                   18-Dec-2020 14:44:21
    number of iterations   : 9                         18-Dec-2020 14:44:21
    number of reformations : 9                         18-Dec-2020 14:44:21
------- converged at time : 0.505581                   18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.533511                   18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.563855                   18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.59613                    18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.62995                    18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.665006                   18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.701051                   18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.737887                   18-Dec-2020 14:44:21
    number of iterations   : 8                         18-Dec-2020 14:44:21
    number of reformations : 8                         18-Dec-2020 14:44:21
------- converged at time : 0.775356                   18-Dec-2020 14:44:21
    number of iterations   : 7                         18-Dec-2020 14:44:21
    number of reformations : 7                         18-Dec-2020 14:44:21
------- converged at time : 0.813331                   18-Dec-2020 14:44:21
    number of iterations   : 7                         18-Dec-2020 14:44:21
    number of reformations : 7                         18-Dec-2020 14:44:21
------- converged at time : 0.851711                   18-Dec-2020 14:44:21
    number of iterations   : 7                         18-Dec-2020 14:44:21
    number of reformations : 7                         18-Dec-2020 14:44:21
------- converged at time : 0.890415                   18-Dec-2020 14:44:21
    number of iterations   : 12                        18-Dec-2020 14:44:21
    number of reformations : 12                        18-Dec-2020 14:44:21
------- converged at time : 0.929378                   18-Dec-2020 14:44:21
    number of iterations   : 7                         18-Dec-2020 14:44:21
    number of reformations : 7                         18-Dec-2020 14:44:21
------- converged at time : 0.968549                   18-Dec-2020 14:44:21
    number of iterations   : 6                         18-Dec-2020 14:44:21
    number of reformations : 6                         18-Dec-2020 14:44:21
------- converged at time : 1                          18-Dec-2020 14:44:21
 Elapsed time : 0:00:35                                18-Dec-2020 14:44:21
 N O R M A L   T E R M I N A T I O N
# Done                                                 18-Dec-2020 14:44:21
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%

Import FEBio results

if runFlag==1 %i.e. a succesful run

Importing nodal displacements from a log file

    dataStruct=importFEBio_logfile(fullfile(savePath,febioLogFileName_disp),1,1);

    %Access data
    N_disp_mat=dataStruct.data; %Displacement
    timeVec=dataStruct.time; %Time

    %Create deformed coordinate set
    V_DEF=N_disp_mat+repmat(V,[1 1 size(N_disp_mat,3)]);

Plotting the simulated results using anim8 to visualize and animate deformations

    DN_magnitude=sqrt(sum(N_disp_mat(:,:,end).^2,2)); %Current displacement magnitude

    % Create basic view and store graphics handle to initiate animation
    hf=cFigure; %Open figure
    gtitle([febioFebFileNamePart,': Press play to animate']);
    title('$u_{mag}$ [mm]','Interpreter','Latex')
    hp1=gpatch(Fb,V_DEF(:,:,end),DN_magnitude,'k',1); %Add graphics object to animate
    hp1.FaceColor='interp';

    hp2=gpatch(Fc,V_DEF(:,:,end),'w','none',1); %Add graphics object to animate

    axisGeom(gca,fontSize);
    colormap(gjet(250)); colorbar;
    caxis([0 max(DN_magnitude)]);
    axis(axisLim(V_DEF)); %Set axis limits statically
    camlight headlight;

    % Set up animation features
    animStruct.Time=timeVec; %The time vector
    for qt=1:1:size(N_disp_mat,3) %Loop over time increments

        DN_magnitude=sqrt(sum(N_disp_mat(:,:,qt).^2,2)); %Current displacement magnitude

        %Set entries in animation structure
        animStruct.Handles{qt}=[hp1 hp1 hp2]; %Handles of objects to animate
        animStruct.Props{qt}={'Vertices','CData','Vertices'}; %Properties of objects to animate
        animStruct.Set{qt}={V_DEF(:,:,qt),DN_magnitude,V_DEF(:,:,qt)}; %Property values for to set in order to animate
    end
    anim8(hf,animStruct); %Initiate animation feature
    drawnow;
end

GIBBON www.gibboncode.org

Kevin Mattheus Moerman, [email protected]

GIBBON footer text

License: https://github.com/gibbonCode/GIBBON/blob/primary/LICENSE

GIBBON: The Geometry and Image-based Bioengineering add-On. A toolbox for image segmentation, image-based modeling, meshing, and finite element analysis.

Copyright (C) 2006-2020 Kevin Mattheus Moerman

This program is free software: you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation, either version 3 of the License, or (at your option) any later version.

This program is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.

You should have received a copy of the GNU General Public License along with this program. If not, see http://www.gnu.org/licenses/.