DEMO_febio_0036_sphere_branches_slide_body_force
Below is a demonstration for:
- Building geometry for a spherical blob with tetrahedral elements which is being aspirated into a tube. This demo consists off:
- Defining the boundary conditions
- Coding the febio structure
- Running the model
- Importing and visualizing the displacement results
Contents
Keywords
- febio_spec version 2.5
- febio, FEBio
- indentation
- contact, sliding, friction
- rigid body constraints
- tetrahedral elements, tet4
- triangular elements, tri3
- shell elements
- sphere
- static, solid
- hyperelastic, Ogden
- displacement logfile
- stress logfile
clear; close all; clc;
Plot settings
fontSize=15; faceAlpha1=0.8; faceAlpha2=0.3; markerSize=40; lineWidth=3; cMap=blood(250);
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=fullfile(savePath,[febioFebFileNamePart,'.txt']); %FEBio log file name febioLogFileName_disp=[febioFebFileNamePart,'_disp_out.txt']; %Log file name for exporting displacement febioLogFileName_strainEnergy=[febioFebFileNamePart,'_energy_out.txt']; %Log file name for exporting strain energy density % Sphere parameters sphereRadius=3;% numElementsMantel=6; % Ground plate parameters tubeRadius=sphereRadius.*[1 0.1]; tubeAngle=3*(pi/180); tubeLength=abs(diff(tubeRadius))/tan(tubeAngle); % Material parameter set c1=1e-3; %Shear-modulus-like parameter MPa m1=2; %Material parameter setting degree of non-linearity k_factor=10; %Bulk modulus factor k=c1*k_factor; %Bulk modulus d=1e-9; %Density % FEA control settings max_refs=25; %Max reforms max_ups=0; %Set to zero to use full-Newton iterations opt_iter=15; %Optimum number of iterations max_retries=25; %Maximum number of retires symmetric_stiffness=0; min_residual=1e-20; analysisType1='dynamic'; timeTotal1=1; %Analysis time numTimeSteps1=100; %Number of time steps desired step_size1=timeTotal1/numTimeSteps1; dtmin1=(timeTotal1/numTimeSteps1)/100; %Minimum time step size dtmax1=timeTotal1/10; %Maximum time step size analysisType2='dynamic'; timeTotal2=100; %Analysis time numTimeSteps2=10; %Number of time steps desired step_size2=timeTotal2/numTimeSteps2; dtmin2=(timeTotal2/numTimeSteps2)/100; %Minimum time step size dtmax2=timeTotal2/2; %Maximum time step size timeTotal=timeTotal1+timeTotal2; %Contact parameters contactPenalty=20; laugon=0; minaug=1; maxaug=10; fric_coeff=0.7; %Specifying load sphereVolume=4/3*(pi*sphereRadius^3); %Sphere Volume in mm^3 sphereMass=sphereVolume.*d; %Sphere mass in tone sphereSectionArea=pi*sphereRadius^2; bodyLoadMagnitude=(9.81*1000)*75; forceBodyLoad=sphereMass.*bodyLoadMagnitude; stressBodyLoad=forceBodyLoad/sphereSectionArea;
Creating model geometry and mesh
%Control settings cPar.sphereRadius=sphereRadius; cPar.coreRadius=cPar.sphereRadius/2; cPar.numElementsMantel=numElementsMantel; cPar.numElementsCore=round(numElementsMantel*1.5); cPar.outputStructType=2; cPar.makeHollow=0; cPar.cParSmooth.n=25; %Creating sphere [meshOutput]=hexMeshSphere(cPar); % Access model element and patch data Fb_blob=meshOutput.facesBoundary; Cb_blob=meshOutput.boundaryMarker; V_blob=meshOutput.nodes; E_blob=meshOutput.elements;
Visualize blob mesh
hFig=cFigure; subplot(1,2,1); hold on; gpatch(Fb_blob,V_blob,Cb_blob,'k',0.8); patchNormPlot(Fb_blob,V_blob); axisGeom(gca,fontSize); colormap(gjet); icolorbar; camlight headlight; hs=subplot(1,2,2); hold on; title('Cut view of solid mesh','FontSize',fontSize); optionStruct.hFig=[hFig hs]; gpatch(Fb_blob,V_blob,'kw','none',0.25); meshView(meshOutput,optionStruct); axisGeom(gca,fontSize); drawnow;

Creating tube model
pointSpacingBlob=mean(patchEdgeLengths(Fb_blob,V_blob)); pointSpacingTube=pointSpacingBlob/2; rEnd=sphereRadius+(sphereRadius.*((sphereRadius-tubeRadius(2))/tubeLength)); V_curve_tube=[sphereRadius rEnd 0; -tubeLength tubeRadius(2) 0;]; nResample=ceil(max(pathLength(V_curve_tube))./pointSpacingTube); V_curve_tube=evenlySampleCurve(V_curve_tube,nResample,'pchip',0); cPar.closeLoopOpt=1; cPar.numSteps=[]; %If empty the number of steps is derived from point spacing of input curve cPar.w=[1 0 0]; [F_tube,V_tube]=polyRevolve(V_curve_tube,cPar); center_of_mass_tube=mean(V_tube,1);
Join model node sets
V=[V_blob; V_tube; ]; F_tube=F_tube+size(V_blob,1);
Visualizing model
cFigure; hold on; gtitle('Model components',fontSize); hl(1)=gpatch(Fb_blob,V,'rw','k',0.8); hl(2)=gpatch(F_tube,V,'kw','k',0.5); legend(hl,{'Blob','Tube'}); clear hl; axisGeom(gca,fontSize); camlight headlight; drawnow;


Get contact surfaces
F_contact_blob=Fb_blob;
Visualize contact surfaces
cFigure; hold on; title('Tube blob contact pair','fontsize',fontSize); hl(1)=gpatch(F_tube,V,'rw','k',0.8); patchNormPlot(F_tube,V); hl(2)=gpatch(F_contact_blob,V,'kw','k',0.5); patchNormPlot(F_contact_blob,V); legend(hl,{'Master','Slave'}); clear hl; 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='2.5'; %Module section febio_spec.Module.ATTR.type='solid'; %Control section stepStruct1.Control.analysis.ATTR.type=analysisType1; stepStruct1.Control.time_steps=numTimeSteps1; stepStruct1.Control.step_size=step_size1; stepStruct1.Control.time_stepper.dtmin=dtmin1; stepStruct1.Control.time_stepper.dtmax=dtmax1; stepStruct1.Control.time_stepper.max_retries=max_retries; stepStruct1.Control.time_stepper.opt_iter=opt_iter; stepStruct1.Control.max_refs=max_refs; stepStruct1.Control.max_ups=max_ups; stepStruct1.Control.symmetric_stiffness=symmetric_stiffness; stepStruct1.Control.min_residual=min_residual; stepStruct2.Control.analysis.ATTR.type=analysisType2; stepStruct2.Control.time_steps=numTimeSteps2; stepStruct2.Control.step_size=step_size2; stepStruct2.Control.time_stepper.dtmin=dtmin2; stepStruct2.Control.time_stepper.dtmax=dtmax2; stepStruct2.Control.time_stepper.max_retries=max_retries; stepStruct2.Control.time_stepper.opt_iter=opt_iter; stepStruct2.Control.max_refs=max_refs; stepStruct2.Control.max_ups=max_ups; stepStruct2.Control.symmetric_stiffness=symmetric_stiffness; stepStruct2.Control.min_residual=min_residual; %Add template based default settings to proposed control section [stepStruct1.Control]=structComplete(stepStruct1.Control,febio_spec.Control,1); %Complement provided with default if missing [stepStruct2.Control]=structComplete(stepStruct2.Control,febio_spec.Control,1); %Complement provided with default if missing %Remove control field (part of template) since step specific control sections are used febio_spec=rmfield(febio_spec,'Control'); febio_spec.Step{1}.Control=stepStruct1.Control; febio_spec.Step{1}.ATTR.id=1; febio_spec.Step{2}.Control=stepStruct2.Control; febio_spec.Step{2}.ATTR.id=2; %Material section febio_spec.Material.material{1}.ATTR.type='Ogden unconstrained'; febio_spec.Material.material{1}.ATTR.id=1; febio_spec.Material.material{1}.c1=c1; febio_spec.Material.material{1}.m1=m1; febio_spec.Material.material{1}.c2=c1; febio_spec.Material.material{1}.m2=-m1; febio_spec.Material.material{1}.cp=k; febio_spec.Material.material{1}.density=d; febio_spec.Material.material{2}.ATTR.type='rigid body'; febio_spec.Material.material{2}.ATTR.id=2; febio_spec.Material.material{2}.density=1; febio_spec.Material.material{2}.center_of_mass=center_of_mass_tube; %Geometry section % -> Nodes febio_spec.Geometry.Nodes{1}.ATTR.name='nodeSet_all'; %The node set name febio_spec.Geometry.Nodes{1}.node.ATTR.id=(1:size(V,1))'; %The node id's febio_spec.Geometry.Nodes{1}.node.VAL=V; %The nodel coordinates % -> Elements febio_spec.Geometry.Elements{1}.ATTR.type='hex8'; %Element type of this set febio_spec.Geometry.Elements{1}.ATTR.mat=1; %material index for this set febio_spec.Geometry.Elements{1}.ATTR.name='Blob'; %Name of the element set febio_spec.Geometry.Elements{1}.elem.ATTR.id=(1:1:size(E_blob,1))'; %Element id's febio_spec.Geometry.Elements{1}.elem.VAL=E_blob; febio_spec.Geometry.Elements{2}.ATTR.type='quad4'; %Element type of this set febio_spec.Geometry.Elements{2}.ATTR.mat=2; %material index for this set febio_spec.Geometry.Elements{2}.ATTR.name='Tube'; %Name of the element set febio_spec.Geometry.Elements{2}.elem.ATTR.id=size(E_blob,1)+(1:1:size(F_tube,1))'; %Element id's febio_spec.Geometry.Elements{2}.elem.VAL=F_tube; % % -> Surfaces febio_spec.Geometry.Surface{1}.ATTR.name='contact_master1'; febio_spec.Geometry.Surface{1}.quad4.ATTR.lid=(1:1:size(F_tube,1))'; febio_spec.Geometry.Surface{1}.quad4.VAL=F_tube; febio_spec.Geometry.Surface{2}.ATTR.name='contact_slave1'; febio_spec.Geometry.Surface{2}.quad4.ATTR.lid=(1:1:size(F_contact_blob,1))'; febio_spec.Geometry.Surface{2}.quad4.VAL=F_contact_blob; % -> Surface pairs febio_spec.Geometry.SurfacePair{1}.ATTR.name='Contact1_tube_blob'; febio_spec.Geometry.SurfacePair{1}.master.ATTR.surface=febio_spec.Geometry.Surface{1}.ATTR.name; febio_spec.Geometry.SurfacePair{1}.slave.ATTR.surface=febio_spec.Geometry.Surface{2}.ATTR.name; %Boundary condition section % -> Fix boundary conditions % febio_spec.Boundary.fix{1}.ATTR.bc='x'; % febio_spec.Boundary.fix{1}.ATTR.node_set=febio_spec.Geometry.NodeSet{1}.ATTR.name; % febio_spec.Boundary.fix{1}.ATTR.bc='y'; % febio_spec.Boundary.fix{1}.ATTR.node_set=febio_spec.Geometry.NodeSet{1}.ATTR.name; % febio_spec.Boundary.fix{2}.ATTR.bc='z'; % febio_spec.Boundary.fix{2}.ATTR.node_set=febio_spec.Geometry.NodeSet{1}.ATTR.name; febio_spec.Loads.body_load{1}.ATTR.type='const'; febio_spec.Loads.body_load{1}.x.VAL=bodyLoadMagnitude; febio_spec.Loads.body_load{1}.x.ATTR.lc=1; % -> Prescribed boundary conditions on the rigid body febio_spec.Boundary.rigid_body{1}.ATTR.mat=2; febio_spec.Boundary.rigid_body{1}.fixed{1}.ATTR.bc='x'; febio_spec.Boundary.rigid_body{1}.fixed{2}.ATTR.bc='y'; febio_spec.Boundary.rigid_body{1}.fixed{3}.ATTR.bc='z'; febio_spec.Boundary.rigid_body{1}.fixed{4}.ATTR.bc='Rx'; febio_spec.Boundary.rigid_body{1}.fixed{5}.ATTR.bc='Ry'; febio_spec.Boundary.rigid_body{1}.fixed{6}.ATTR.bc='Rz'; %Contact section febio_spec.Contact.contact{1}.ATTR.surface_pair=febio_spec.Geometry.SurfacePair{1}.ATTR.name; 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 febio_spec.LoadData.loadcurve{1}.ATTR.id=1; febio_spec.LoadData.loadcurve{1}.ATTR.type='linear'; febio_spec.LoadData.loadcurve{1}.point.VAL=[0 0; timeTotal1 1; timeTotal 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=','; febio_spec.Output.logfile.node_data{1}.VAL=1:size(V,1); febio_spec.Output.logfile.element_data{1}.ATTR.file=febioLogFileName_strainEnergy; febio_spec.Output.logfile.element_data{1}.ATTR.data='sed'; febio_spec.Output.logfile.element_data{1}.ATTR.delim=','; febio_spec.Output.logfile.element_data{1}.VAL=1:size(E_blob,1);
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.disp_log_on=1; %Display convergence information in the command window febioAnalysis.runMode='internal';%'internal'; febioAnalysis.t_check=0.25; %Time for checking log file (dont set too small) febioAnalysis.maxtpi=1e99; %Max analysis time febioAnalysis.maxLogCheckTime=3; %Max log file checking time [runFlag]=runMonitorFEBio(febioAnalysis);%START FEBio NOW!!!!!!!!
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% --- STARTING FEBIO JOB --- 04-Jun-2019 13:06:53 =========================================================================== ________ _________ _________ __ _________ | |\ | |\ | |\ | |\ / \\ | ____|| | ____|| | __ || |__|| | ___ || | |\___\| | |\___\| | |\_| || \_\| | // \ || | || | || | || | || __ | || | || | ||__ | ||__ | ||_| || | |\ | || | || | |\ | |\ | \\ | || | || | || | ___|| | ___|| | ___ || | || | || | || | |\__\| | |\__\| | |\__| || | || | || | || | || | || | || | || | || | || | || | || | ||___ | ||__| || | || | \\__/ || | || | |\ | || | || | || |___|| |________|| |__________|| |__|| \_________// 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 --- v e r s i o n - 2 . 9 . 0 --- http://febio.org FEBio is a registered trademark. copyright (c) 2006-2019 - All rights reserved =========================================================================== Success loading plugin NeoHookeanPi.so (version 0.0.0) Reading file /mnt/data/MATLAB/GIBBON/data/temp/tempModel.feb ...SUCCESS! ************************************************************************* * WARNING * * * * 230 isolated vertices removed. * ************************************************************************* ]0;(step 1/2: 0%) tempModel.feb - FEBio 2.9.0.0 ===== beginning time step 1 : 0.01 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.01 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.599144e-10 1.697853e-08 0.000000e+00 energy 1.507741e-04 8.884648e-18 1.507741e-06 displacement 1.328960e+02 1.328960e+02 1.328960e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.01 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.599144e-10 9.046396e-11 0.000000e+00 energy 1.507741e-04 7.046765e-08 1.507741e-06 displacement 1.328960e+02 1.072782e-03 1.328306e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.01 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.599144e-10 4.672979e-12 0.000000e+00 energy 1.507741e-04 3.020645e-13 1.507741e-06 displacement 1.328960e+02 2.311958e-05 1.328186e-04 ------- converged at time : 0.01 ]0;(step 1/2: 1%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.028 ===== beginning time step 2 : 0.038 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.038 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.907924e-09 9.797393e-06 0.000000e+00 energy 2.086246e-03 2.569492e-04 2.086246e-05 displacement 8.837284e+02 8.837284e+02 8.837284e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.038 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.907924e-09 8.403906e-07 0.000000e+00 energy 2.086246e-03 6.968882e-05 2.086246e-05 displacement 8.837284e+02 4.940510e-01 9.092243e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 3 step from line search = 0.491444 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 3.632199e-07 0.000000e+00 energy 2.086246e-03 2.851541e-04 2.086246e-05 displacement 8.837284e+02 9.882740e+00 1.086791e-03 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.038 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.907924e-09 3.989530e-07 0.000000e+00 energy 2.086246e-03 1.233239e-05 2.086246e-05 displacement 8.837284e+02 7.938047e+01 1.733153e-03 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 5 step from line search = 0.403205 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 2.622320e-07 0.000000e+00 energy 2.086246e-03 4.007097e-04 2.086246e-05 displacement 8.837284e+02 1.027968e+03 5.425087e-03 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 6 step from line search = 0.412021 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 1.329287e-07 0.000000e+00 energy 2.086246e-03 3.708121e-05 2.086246e-05 displacement 8.837284e+02 2.843448e+02 8.192075e-03 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 7 step from line search = 0.206465 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 8.392229e-08 0.000000e+00 energy 2.086246e-03 6.701872e-06 2.086246e-05 displacement 8.837284e+02 2.154238e+01 9.053473e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 8 step from line search = 0.203934 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 5.359356e-08 0.000000e+00 energy 2.086246e-03 4.448887e-06 2.086246e-05 displacement 8.837284e+02 1.295454e+01 9.751060e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 9 step from line search = 0.430328 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 1.752690e-08 0.000000e+00 energy 2.086246e-03 4.752381e-06 2.086246e-05 displacement 8.837284e+02 3.497952e+01 1.095341e-02 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 2.820000e-10 0.000000e+00 energy 2.086246e-03 3.634471e-06 2.086246e-05 displacement 8.837284e+02 5.941470e+01 1.262496e-02 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 1.175325e-11 0.000000e+00 energy 2.086246e-03 2.423690e-08 2.086246e-05 displacement 8.837284e+02 1.515239e-02 1.260916e-02 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.038 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.907924e-09 5.564500e-17 0.000000e+00 energy 2.086246e-03 1.584039e-12 2.086246e-05 displacement 8.837284e+02 1.536419e-03 1.260497e-02 ------- converged at time : 0.038 ]0;(step 1/2: 4%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0364984 ===== beginning time step 3 : 0.0744984 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.0744984 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.795379e-07 5.674292e-07 0.000000e+00 energy 2.702191e-04 2.424944e-05 2.702191e-06 displacement 3.318997e+01 3.318997e+01 3.318997e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.0744984 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.795379e-07 1.206777e-07 0.000000e+00 energy 2.702191e-04 9.550649e-06 2.702191e-06 displacement 3.318997e+01 6.052865e-02 3.593959e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.0744984 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.795379e-07 2.122571e-07 0.000000e+00 energy 2.702191e-04 3.687442e-05 2.702191e-06 displacement 3.318997e+01 1.473762e+01 9.468104e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.0744984 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 4 step from line search = 0.469583 convergence norms : INITIAL CURRENT REQUIRED residual 1.795379e-07 1.540465e-07 0.000000e+00 energy 2.702191e-04 1.974832e-04 2.702191e-06 displacement 3.318997e+01 7.777944e+02 1.405424e-03 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.0744984 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.795379e-07 3.664515e-08 0.000000e+00 energy 2.702191e-04 2.035377e-04 2.702191e-06 displacement 3.318997e+01 8.684592e+02 4.480283e-03 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.0744984 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.795379e-07 8.991351e-11 0.000000e+00 energy 2.702191e-04 8.974430e-08 2.702191e-06 displacement 3.318997e+01 1.261007e-01 4.435449e-03 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.0744984 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.795379e-07 2.510668e-12 0.000000e+00 energy 2.702191e-04 2.018749e-08 2.702191e-06 displacement 3.318997e+01 1.403498e-01 4.444940e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.0744984 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.795379e-07 1.772123e-18 0.000000e+00 energy 2.702191e-04 1.169688e-12 2.702191e-06 displacement 3.318997e+01 3.363286e-04 4.446343e-03 ------- converged at time : 0.0744984 ]0;(step 1/2: 7%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0491988 ===== beginning time step 4 : 0.123697 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 8.946163e-07 0.000000e+00 energy 2.088533e-04 2.911817e-05 2.088533e-06 displacement 2.283839e+01 2.283839e+01 2.283839e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 7.781446e-08 0.000000e+00 energy 2.088533e-04 8.597526e-06 2.088533e-06 displacement 2.283839e+01 5.598935e-02 2.506150e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 1.293463e-07 0.000000e+00 energy 2.088533e-04 1.153514e-05 2.088533e-06 displacement 2.283839e+01 1.010322e+00 3.565597e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 4 step from line search = 0.198640 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 2.017644e-07 0.000000e+00 energy 2.088533e-04 2.028370e-04 2.088533e-06 displacement 2.283839e+01 6.584453e+01 1.870677e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 5 step from line search = 0.150000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 1.676260e-07 0.000000e+00 energy 2.088533e-04 1.181178e-04 2.088533e-06 displacement 2.283839e+01 3.406883e+01 3.768993e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 6 step from line search = 0.389159 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 1.116886e-07 0.000000e+00 energy 2.088533e-04 8.031582e-05 2.088533e-06 displacement 2.283839e+01 2.270621e+02 1.176757e-03 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 3.002232e-09 0.000000e+00 energy 2.088533e-04 4.420363e-05 2.088533e-06 displacement 2.283839e+01 5.024563e+02 3.168099e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 8 step from line search = 0.035926 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 2.795053e-09 0.000000e+00 energy 2.088533e-04 7.173977e-07 2.088533e-06 displacement 2.283839e+01 5.164286e-02 3.156039e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 9 step from line search = 0.500000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 1.862687e-07 0.000000e+00 energy 2.088533e-04 7.594450e-05 2.088533e-06 displacement 2.283839e+01 1.137593e+01 2.996712e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 7.300474e-09 0.000000e+00 energy 2.088533e-04 9.592914e-06 2.088533e-06 displacement 2.283839e+01 8.595696e+00 2.852782e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 23 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 1.195203e-10 0.000000e+00 energy 2.088533e-04 2.164783e-07 2.088533e-06 displacement 2.283839e+01 7.942612e-01 2.908326e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 29 stiffness matrix reformations = 12 step from line search = 0.123959 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 9.232972e-11 0.000000e+00 energy 2.088533e-04 1.003803e-08 2.088533e-06 displacement 2.283839e+01 1.113049e-02 2.907545e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 30 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 1.137359e-10 0.000000e+00 energy 2.088533e-04 3.887698e-08 2.088533e-06 displacement 2.283839e+01 7.096206e-01 2.903394e-03 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.123697 stiffness updates = 0 right hand side evaluations = 33 stiffness matrix reformations = 14 step from line search = 0.256168 convergence norms : INITIAL CURRENT REQUIRED residual 4.759630e-07 6.597709e-11 0.000000e+00 energy 2.088533e-04 1.634197e-10 2.088533e-06 displacement 2.283839e+01 2.331923e-04 2.904799e-03 ------- converged at time : 0.123697 ]0;(step 1/2: 12%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0509818 ===== beginning time step 5 : 0.174679 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.174679 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.046169e-07 2.172630e-06 0.000000e+00 energy 8.687078e-04 7.417030e-05 8.687078e-06 displacement 9.652321e+01 9.652321e+01 9.652321e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.174679 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.046169e-07 2.814839e-07 0.000000e+00 energy 8.687078e-04 2.748226e-05 8.687078e-06 displacement 9.652321e+01 2.089133e-01 1.051941e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 7.877926e-07 0.000000e+00 energy 8.687078e-04 6.102662e-05 8.687078e-06 displacement 9.652321e+01 2.345642e+01 2.203430e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 4 step from line search = 0.131679 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 6.091476e-07 0.000000e+00 energy 8.687078e-04 6.029990e-04 8.687078e-06 displacement 9.652321e+01 8.217732e+01 5.339233e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 5 step from line search = 0.079570 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 5.569789e-07 0.000000e+00 energy 8.687078e-04 3.665930e-04 8.687078e-06 displacement 9.652321e+01 4.310519e+01 8.604153e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 6 step from line search = 0.081028 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 5.468131e-07 0.000000e+00 energy 8.687078e-04 2.735611e-04 8.687078e-06 displacement 9.652321e+01 4.156993e+01 1.265176e-03 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 7 step from line search = 0.218520 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 7.355644e-07 0.000000e+00 energy 8.687078e-04 2.631769e-04 8.687078e-06 displacement 9.652321e+01 2.416340e+02 2.607443e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 8 step from line search = 0.380724 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 4.727124e-07 0.000000e+00 energy 8.687078e-04 3.624372e-06 8.687078e-06 displacement 9.652321e+01 4.713744e+02 5.247518e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 9 step from line search = 0.246498 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 2.697445e-07 0.000000e+00 energy 8.687078e-04 1.436284e-06 8.687078e-06 displacement 9.652321e+01 7.209302e+01 6.522768e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 10 step from line search = 0.095591 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 2.206926e-07 0.000000e+00 energy 8.687078e-04 1.142739e-06 8.687078e-06 displacement 9.652321e+01 6.123476e+00 6.919038e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 11 step from line search = 0.082876 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 1.858090e-07 0.000000e+00 energy 8.687078e-04 1.083516e-06 8.687078e-06 displacement 9.652321e+01 3.792521e+00 7.238756e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 30 stiffness matrix reformations = 12 step from line search = 0.090771 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 1.536898e-07 0.000000e+00 energy 8.687078e-04 1.139159e-06 8.687078e-06 displacement 9.652321e+01 3.842429e+00 7.567651e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 32 stiffness matrix reformations = 13 step from line search = 0.107402 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 1.224989e-07 0.000000e+00 energy 8.687078e-04 1.238853e-06 8.687078e-06 displacement 9.652321e+01 4.455732e+00 7.929623e-03 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 35 stiffness matrix reformations = 14 step from line search = 0.274571 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 6.497948e-08 0.000000e+00 energy 8.687078e-04 2.878167e-06 8.687078e-06 displacement 9.652321e+01 2.350261e+01 8.792305e-03 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 41 stiffness matrix reformations = 15 step from line search = 0.082178 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 5.473786e-08 0.000000e+00 energy 8.687078e-04 7.767369e-07 8.687078e-06 displacement 9.652321e+01 1.162075e+00 8.988750e-03 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 47 stiffness matrix reformations = 16 step from line search = 0.500000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 1.558322e-08 0.000000e+00 energy 8.687078e-04 9.924122e-06 8.687078e-06 displacement 9.652321e+01 3.679572e+01 1.013502e-02 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 49 stiffness matrix reformations = 17 step from line search = 0.506838 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 4.230825e-09 0.000000e+00 energy 8.687078e-04 3.641794e-06 8.687078e-06 displacement 9.652321e+01 9.815986e+00 1.072665e-02 Reforming stiffness matrix: reformation #18 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 18 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 50 stiffness matrix reformations = 18 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 1.158515e-09 0.000000e+00 energy 8.687078e-04 3.915173e-06 8.687078e-06 displacement 9.652321e+01 1.345941e+01 1.140873e-02 Reforming stiffness matrix: reformation #19 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 19 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 51 stiffness matrix reformations = 19 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 1.742047e-10 0.000000e+00 energy 8.687078e-04 1.840953e-07 8.687078e-06 displacement 9.652321e+01 4.294670e-01 1.144150e-02 Reforming stiffness matrix: reformation #20 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 20 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 52 stiffness matrix reformations = 20 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 2.254100e-11 0.000000e+00 energy 8.687078e-04 4.807602e-08 8.687078e-06 displacement 9.652321e+01 2.824882e-01 1.148645e-02 Reforming stiffness matrix: reformation #21 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 21 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 53 stiffness matrix reformations = 21 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 7.770051e-12 0.000000e+00 energy 8.687078e-04 2.416346e-08 8.687078e-06 displacement 9.652321e+01 8.382003e-02 1.151071e-02 Reforming stiffness matrix: reformation #22 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 22 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 54 stiffness matrix reformations = 22 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 4.924281e-13 0.000000e+00 energy 8.687078e-04 7.373750e-09 8.687078e-06 displacement 9.652321e+01 3.092600e-02 1.152798e-02 Reforming stiffness matrix: reformation #23 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 23 Nonlinear solution status: time= 0.174679 stiffness updates = 0 right hand side evaluations = 55 stiffness matrix reformations = 23 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 9.046169e-07 1.206488e-19 0.000000e+00 energy 8.687078e-04 7.388631e-14 8.687078e-06 displacement 9.652321e+01 5.396947e-05 1.152799e-02 ------- converged at time : 0.174679 ]0;(step 1/2: 17%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0411908 ===== beginning time step 6 : 0.21587 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.21587 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.999051e-06 2.179588e-06 0.000000e+00 energy 7.459426e-05 5.390483e-05 7.459426e-07 displacement 2.714184e+00 2.714184e+00 2.714184e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.21587 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.999051e-06 4.868654e-08 0.000000e+00 energy 7.459426e-05 7.407601e-06 7.459426e-07 displacement 2.714184e+00 3.870402e-02 3.367274e-06 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.21587 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.999051e-06 9.467180e-09 0.000000e+00 energy 7.459426e-05 1.395111e-06 7.459426e-07 displacement 2.714184e+00 8.966694e-02 4.482149e-06 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.21587 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.999051e-06 1.108368e-08 0.000000e+00 energy 7.459426e-05 1.727816e-06 7.459426e-07 displacement 2.714184e+00 5.301689e-01 7.813189e-06 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 5 step from line search = 0.557466 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 1.543199e-08 0.000000e+00 energy 7.459426e-05 9.931637e-06 7.459426e-07 displacement 2.714184e+00 3.355851e+01 7.172625e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 6 step from line search = 0.424996 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 2.293423e-08 0.000000e+00 energy 7.459426e-05 2.688785e-06 7.459426e-07 displacement 2.714184e+00 1.067963e+01 1.250652e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 7 step from line search = 0.365754 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 1.031163e-08 0.000000e+00 energy 7.459426e-05 1.134679e-06 7.459426e-07 displacement 2.714184e+00 2.563784e+00 1.556447e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 8 step from line search = 0.414614 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 3.821910e-09 0.000000e+00 energy 7.459426e-05 6.531069e-07 7.459426e-07 displacement 2.714184e+00 1.114203e+00 1.769743e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 0.353373 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 2.543210e-09 0.000000e+00 energy 7.459426e-05 2.587397e-07 7.459426e-07 displacement 2.714184e+00 3.102477e-01 1.880543e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 0.356826 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 1.063874e-09 0.000000e+00 energy 7.459426e-05 1.675957e-08 7.459426e-07 displacement 2.714184e+00 1.181315e-01 1.948153e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 23 stiffness matrix reformations = 11 step from line search = 0.037933 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 9.847378e-10 0.000000e+00 energy 7.459426e-05 8.135326e-10 7.459426e-07 displacement 2.714184e+00 6.151904e-04 1.952963e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 28 stiffness matrix reformations = 12 step from line search = 0.500000 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 2.655232e-10 0.000000e+00 energy 7.459426e-05 3.793458e-08 7.459426e-07 displacement 2.714184e+00 9.966336e-02 2.015138e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 29 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 3.629593e-13 0.000000e+00 energy 7.459426e-05 8.119253e-10 7.459426e-07 displacement 2.714184e+00 9.243889e-02 2.068932e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.21587 stiffness updates = 0 right hand side evaluations = 30 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.999051e-06 3.563101e-19 0.000000e+00 energy 7.459426e-05 2.233066e-13 7.459426e-07 displacement 2.714184e+00 9.067319e-05 2.069141e-04 ------- converged at time : 0.21587 ]0;(step 1/2: 22%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0432549 ===== beginning time step 7 : 0.259125 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.259125 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.305745e-06 3.657668e-06 0.000000e+00 energy 7.242657e-04 1.069096e-04 7.242657e-06 displacement 7.136731e+01 7.136731e+01 7.136731e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.259125 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.305745e-06 2.474247e-07 0.000000e+00 energy 7.242657e-04 2.858771e-05 7.242657e-06 displacement 7.136731e+01 2.410693e-01 7.944646e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.259125 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.305745e-06 3.228533e-07 0.000000e+00 energy 7.242657e-04 2.489930e-05 7.242657e-06 displacement 7.136731e+01 3.901040e+00 1.161554e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.259125 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.305745e-06 6.845540e-07 0.000000e+00 energy 7.242657e-04 6.162957e-06 7.242657e-06 displacement 7.136731e+01 7.863252e+01 3.760070e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 5 step from line search = 0.447312 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 8.084243e-07 0.000000e+00 energy 7.242657e-04 5.996306e-05 7.242657e-06 displacement 7.136731e+01 7.099721e+02 2.097275e-03 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 6 step from line search = 0.305133 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 3.978582e-07 0.000000e+00 energy 7.242657e-04 5.008756e-06 7.242657e-06 displacement 7.136731e+01 1.073784e+02 3.150694e-03 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 7 step from line search = 0.500000 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 1.143249e-07 0.000000e+00 energy 7.242657e-04 5.096216e-05 7.242657e-06 displacement 7.136731e+01 1.454931e+02 4.643890e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 8 step from line search = 0.358984 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 4.871648e-08 0.000000e+00 energy 7.242657e-04 1.609039e-05 7.242657e-06 displacement 7.136731e+01 1.919906e+01 5.248423e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 9 step from line search = 0.525267 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 1.380970e-08 0.000000e+00 energy 7.242657e-04 1.024134e-05 7.242657e-06 displacement 7.136731e+01 1.671016e+01 5.841280e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 7.620402e-10 0.000000e+00 energy 7.242657e-04 2.903936e-06 7.242657e-06 displacement 7.136731e+01 1.396903e+01 6.414227e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 2.201884e-11 0.000000e+00 energy 7.242657e-04 1.243901e-08 7.242657e-06 displacement 7.136731e+01 9.582712e-03 6.408735e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.259125 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.305745e-06 1.847944e-17 0.000000e+00 energy 7.242657e-04 1.131766e-12 7.242657e-06 displacement 7.136731e+01 6.164582e-04 6.406568e-03 ------- converged at time : 0.259125 ]0;(step 1/2: 26%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0499527 ===== beginning time step 8 : 0.309077 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 4.186191e-06 0.000000e+00 energy 1.946847e-04 9.856231e-05 1.946847e-06 displacement 1.120348e+01 1.120348e+01 1.120348e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 6.896309e-08 0.000000e+00 energy 1.946847e-04 1.159612e-05 1.946847e-06 displacement 1.120348e+01 6.593222e-02 1.289338e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 6.239229e-08 0.000000e+00 energy 1.946847e-04 4.864476e-06 1.946847e-06 displacement 1.120348e+01 2.547981e-01 1.647778e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 4.872584e-08 0.000000e+00 energy 1.946847e-04 5.416741e-06 1.946847e-06 displacement 1.120348e+01 8.377149e-01 2.433700e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 5 step from line search = 0.452476 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 1.608804e-07 0.000000e+00 energy 1.946847e-04 7.618247e-07 1.946847e-06 displacement 1.120348e+01 5.065648e+01 1.365027e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 6 step from line search = 0.521760 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 5.887724e-08 0.000000e+00 energy 1.946847e-04 1.360333e-06 1.946847e-06 displacement 1.120348e+01 7.726041e+01 4.047117e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 7 step from line search = 0.276350 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 3.172418e-08 0.000000e+00 energy 1.946847e-04 9.807288e-07 1.946847e-06 displacement 1.120348e+01 5.338034e+00 4.963159e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 8 step from line search = 0.206670 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 2.041637e-08 0.000000e+00 energy 1.946847e-04 1.137455e-07 1.946847e-06 displacement 1.120348e+01 1.648273e+00 5.512242e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 0.150121 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 1.481403e-08 0.000000e+00 energy 1.946847e-04 6.982637e-08 1.946847e-06 displacement 1.120348e+01 5.482388e-01 5.842650e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 0.180549 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 9.991463e-09 0.000000e+00 energy 1.946847e-04 7.940993e-08 1.946847e-06 displacement 1.120348e+01 5.420016e-01 6.179263e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 11 step from line search = 0.166361 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 6.973206e-09 0.000000e+00 energy 1.946847e-04 5.458370e-08 1.946847e-06 displacement 1.120348e+01 3.147590e-01 6.441612e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 12 step from line search = 0.150607 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 5.185565e-09 0.000000e+00 energy 1.946847e-04 1.209200e-08 1.946847e-06 displacement 1.120348e+01 1.834189e-01 6.645435e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 23 stiffness matrix reformations = 13 step from line search = 0.367529 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 2.290184e-09 0.000000e+00 energy 1.946847e-04 3.736975e-09 1.946847e-06 displacement 1.120348e+01 7.373499e-01 7.059202e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 25 stiffness matrix reformations = 14 step from line search = 0.415845 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 7.914562e-10 0.000000e+00 energy 1.946847e-04 4.717368e-08 1.946847e-06 displacement 1.120348e+01 3.819041e-01 7.358637e-04 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 27 stiffness matrix reformations = 15 step from line search = 0.337706 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 3.660846e-10 0.000000e+00 energy 1.946847e-04 3.311122e-09 1.946847e-06 displacement 1.120348e+01 9.104187e-02 7.505304e-04 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 28 stiffness matrix reformations = 16 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 1.044563e-11 0.000000e+00 energy 1.946847e-04 1.454064e-08 1.946847e-06 displacement 1.120348e+01 2.821748e-01 7.753286e-04 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.309077 stiffness updates = 0 right hand side evaluations = 29 stiffness matrix reformations = 17 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.664053e-06 4.546105e-17 0.000000e+00 energy 1.946847e-04 5.960226e-12 1.946847e-06 displacement 1.120348e+01 5.477799e-04 7.752619e-04 ------- converged at time : 0.309077 ]0;(step 1/2: 31%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0469285 ===== beginning time step 9 : 0.356006 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.379226e-06 5.550758e-06 0.000000e+00 energy 5.051263e-04 1.353134e-04 5.051263e-06 displacement 4.076522e+01 4.076522e+01 4.076522e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.379226e-06 1.520332e-07 0.000000e+00 energy 5.051263e-04 2.131919e-05 5.051263e-06 displacement 4.076522e+01 1.294157e-01 4.523664e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.379226e-06 2.546794e-07 0.000000e+00 energy 5.051263e-04 1.508863e-05 5.051263e-06 displacement 4.076522e+01 1.369581e+00 6.093384e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.379226e-06 2.320134e-07 0.000000e+00 energy 5.051263e-04 5.704659e-06 5.051263e-06 displacement 4.076522e+01 3.656929e+00 9.236005e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 4.379226e-06 1.306924e-06 0.000000e+00 energy 5.051263e-04 5.395464e-04 5.051263e-06 displacement 4.076522e+01 2.780913e+02 6.660256e-04 ************************************************************************* * WARNING * * * * Problem is diverging. Stiffness matrix will now be reformed * ************************************************************************* Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 6 step from line search = 0.424196 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 1.206496e-06 0.000000e+00 energy 5.395464e-04 2.597468e-05 5.395464e-06 displacement 4.076522e+01 1.161329e+02 1.330071e-03 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 7 step from line search = 0.422790 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 4.659062e-07 0.000000e+00 energy 5.395464e-04 1.179437e-05 5.395464e-06 displacement 4.076522e+01 4.961339e+01 1.864269e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 8 step from line search = 0.256742 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 2.615094e-07 0.000000e+00 energy 5.395464e-04 9.558586e-07 5.395464e-06 displacement 4.076522e+01 6.304984e+00 2.062179e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 9 step from line search = 0.210295 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 1.671218e-07 0.000000e+00 energy 5.395464e-04 2.642486e-07 5.395464e-06 displacement 4.076522e+01 2.609743e+00 2.192199e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 10 step from line search = 0.300325 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 8.312900e-08 0.000000e+00 energy 5.395464e-04 1.224509e-06 5.395464e-06 displacement 4.076522e+01 3.220828e+00 2.336213e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 11 step from line search = 0.266032 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 4.597399e-08 0.000000e+00 energy 5.395464e-04 1.709005e-07 5.395464e-06 displacement 4.076522e+01 1.375811e+00 2.429631e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 12 step from line search = 0.275377 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 2.436242e-08 0.000000e+00 energy 5.395464e-04 2.949853e-07 5.395464e-06 displacement 4.076522e+01 7.777983e-01 2.500354e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 13 step from line search = 0.223283 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 1.478028e-08 0.000000e+00 energy 5.395464e-04 1.428938e-07 5.395464e-06 displacement 4.076522e+01 3.055685e-01 2.544919e-03 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 14 step from line search = 0.235692 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 8.923255e-09 0.000000e+00 energy 5.395464e-04 1.585668e-08 5.395464e-06 displacement 4.076522e+01 2.087177e-01 2.580976e-03 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 27 stiffness matrix reformations = 15 step from line search = 0.159885 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 6.464214e-09 0.000000e+00 energy 5.395464e-04 2.716027e-09 5.395464e-06 displacement 4.076522e+01 5.557916e-02 2.599137e-03 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 29 stiffness matrix reformations = 16 step from line search = 0.290149 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 3.270869e-09 0.000000e+00 energy 5.395464e-04 1.691100e-08 5.395464e-06 displacement 4.076522e+01 1.285214e-01 2.627108e-03 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 31 stiffness matrix reformations = 17 step from line search = 0.250831 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 1.847519e-09 0.000000e+00 energy 5.395464e-04 6.257072e-09 5.395464e-06 displacement 4.076522e+01 5.274832e-02 2.645043e-03 Reforming stiffness matrix: reformation #18 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 18 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 33 stiffness matrix reformations = 18 step from line search = 0.508074 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 4.574786e-10 0.000000e+00 energy 5.395464e-04 9.438464e-09 5.395464e-06 displacement 4.076522e+01 1.248118e-01 2.672016e-03 Reforming stiffness matrix: reformation #19 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 19 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 34 stiffness matrix reformations = 19 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 2.395060e-13 0.000000e+00 energy 5.395464e-04 2.361443e-09 5.395464e-06 displacement 4.076522e+01 1.204878e-01 2.697642e-03 Reforming stiffness matrix: reformation #20 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 20 Nonlinear solution status: time= 0.356006 stiffness updates = 0 right hand side evaluations = 35 stiffness matrix reformations = 20 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.306924e-06 7.050767e-20 0.000000e+00 energy 5.395464e-04 8.227653e-14 5.395464e-06 displacement 4.076522e+01 5.631692e-05 2.698172e-03 ------- converged at time : 0.356006 ]0;(step 1/2: 36%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0406546 ===== beginning time step 10 : 0.39666 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 6.617702e-06 0.000000e+00 energy 3.489573e-04 1.543593e-04 3.489573e-06 displacement 2.169128e+01 2.169128e+01 2.169128e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 8.101689e-08 0.000000e+00 energy 3.489573e-04 1.411246e-05 3.489573e-06 displacement 2.169128e+01 8.825551e-02 2.437269e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 1.204570e-07 0.000000e+00 energy 3.489573e-04 9.738539e-06 3.489573e-06 displacement 2.169128e+01 7.582273e-01 3.286396e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 2.474013e-07 0.000000e+00 energy 3.489573e-04 2.100226e-05 3.489573e-06 displacement 2.169128e+01 1.327355e+00 4.641229e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 2.563693e-07 0.000000e+00 energy 3.489573e-04 1.301253e-05 3.489573e-06 displacement 2.169128e+01 2.678409e+01 1.396237e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 7.961545e-07 0.000000e+00 energy 3.489573e-04 1.919190e-04 3.489573e-06 displacement 2.169128e+01 1.952165e+02 6.357955e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 1.556719e-07 0.000000e+00 energy 3.489573e-04 4.433074e-05 3.489573e-06 displacement 2.169128e+01 6.351148e+01 1.092738e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 3.147169e-08 0.000000e+00 energy 3.489573e-04 5.182632e-06 3.489573e-06 displacement 2.169128e+01 5.252596e-01 1.104158e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 5.024017e-07 0.000000e+00 energy 3.489573e-04 3.337816e-05 3.489573e-06 displacement 2.169128e+01 2.340501e+01 1.186761e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 1.190617e-08 0.000000e+00 energy 3.489573e-04 2.056380e-06 3.489573e-06 displacement 2.169128e+01 7.799554e+00 1.192076e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 11 step from line search = 0.494048 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 3.143248e-09 0.000000e+00 energy 3.489573e-04 8.015930e-08 3.489573e-06 displacement 2.169128e+01 2.627008e-01 1.216352e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 12 step from line search = 0.060146 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 2.775576e-09 0.000000e+00 energy 3.489573e-04 1.501659e-09 3.489573e-06 displacement 2.169128e+01 1.398110e-03 1.217931e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 13 step from line search = 0.079568 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 2.352180e-09 0.000000e+00 energy 3.489573e-04 2.722180e-09 3.489573e-06 displacement 2.169128e+01 2.143201e-03 1.219949e-03 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 27 stiffness matrix reformations = 14 step from line search = 0.070666 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 2.031954e-09 0.000000e+00 energy 3.489573e-04 2.114689e-09 3.489573e-06 displacement 2.169128e+01 1.471541e-03 1.221618e-03 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.39666 stiffness updates = 0 right hand side evaluations = 33 stiffness matrix reformations = 15 step from line search = 0.064094 convergence norms : INITIAL CURRENT REQUIRED residual 5.732580e-06 1.780148e-09 0.000000e+00 energy 3.489573e-04 1.702052e-09 3.489573e-06 displacement 2.169128e+01 1.069250e-03 1.223038e-03 ------- converged at time : 0.39666 ]0;(step 1/2: 40%) tempModel.feb - FEBio 2.9.0.0 ===== beginning time step 11 : 0.437315 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 7.409328e-06 0.000000e+00 energy 2.477938e-04 1.711925e-04 2.477938e-06 displacement 8.987889e+00 8.987889e+00 8.987889e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 4.255448e-08 0.000000e+00 energy 2.477938e-04 1.075612e-05 2.477938e-06 displacement 8.987889e+00 8.337169e-02 1.068949e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 4.776626e-08 0.000000e+00 energy 2.477938e-04 5.661700e-06 2.477938e-06 displacement 8.987889e+00 2.197951e-01 1.366090e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 1.458372e-07 0.000000e+00 energy 2.477938e-04 1.384783e-06 2.477938e-06 displacement 8.987889e+00 3.022525e-01 1.777323e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 7.662660e-08 0.000000e+00 energy 2.477938e-04 7.494371e-06 2.477938e-06 displacement 8.987889e+00 2.514178e+00 3.303678e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 7.094440e-08 0.000000e+00 energy 2.477938e-04 8.985008e-06 2.477938e-06 displacement 8.987889e+00 4.917798e+00 6.235712e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 1.832118e-08 0.000000e+00 energy 2.477938e-04 5.950393e-06 2.477938e-06 displacement 8.987889e+00 1.457462e+02 3.958285e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 8.639228e-11 0.000000e+00 energy 2.477938e-04 5.437718e-08 2.477938e-06 displacement 8.987889e+00 1.222691e+00 4.386789e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 1.606276e-16 0.000000e+00 energy 2.477938e-04 2.497808e-11 2.477938e-06 displacement 8.987889e+00 3.153112e-03 4.405522e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.437315 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 6.846358e-06 1.552329e-25 0.000000e+00 energy 2.477938e-04 3.696620e-18 2.477938e-06 displacement 8.987889e+00 7.067400e-08 4.405590e-04 ------- converged at time : 0.437315 ]0;(step 1/2: 44%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0525237 ===== beginning time step 12 : 0.489839 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.489839 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.756429e-06 9.730034e-06 0.000000e+00 energy 8.509401e-04 2.391703e-04 8.509401e-06 displacement 6.732868e+01 6.732868e+01 6.732868e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.489839 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.756429e-06 1.888069e-07 0.000000e+00 energy 8.509401e-04 2.880718e-05 8.509401e-06 displacement 6.732868e+01 2.339599e-01 7.505588e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 4.321588e-07 0.000000e+00 energy 8.509401e-04 1.798168e-05 8.509401e-06 displacement 6.732868e+01 3.051881e+00 1.048029e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 9.816358e-07 0.000000e+00 energy 8.509401e-04 1.560488e-04 8.509401e-06 displacement 6.732868e+01 9.409209e+00 1.723201e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 1.004193e-06 0.000000e+00 energy 8.509401e-04 4.170642e-05 8.509401e-06 displacement 6.732868e+01 2.070373e+02 7.352768e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 6 step from line search = 0.466446 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 9.734635e-07 0.000000e+00 energy 8.509401e-04 2.838717e-05 8.509401e-06 displacement 6.732868e+01 1.130046e+02 1.401169e-03 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.489839 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.756429e-06 2.935564e-07 0.000000e+00 energy 8.509401e-04 4.403354e-05 8.509401e-06 displacement 6.732868e+01 2.837823e+02 2.929289e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 8 step from line search = 0.305066 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 1.509830e-07 0.000000e+00 energy 8.509401e-04 1.566736e-06 8.509401e-06 displacement 6.732868e+01 4.236589e+00 2.986665e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 0.036871 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 1.402256e-07 0.000000e+00 energy 8.509401e-04 2.182037e-09 8.509401e-06 displacement 6.732868e+01 3.938353e-02 2.995744e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 10 step from line search = 0.500000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 5.202650e-08 0.000000e+00 energy 8.509401e-04 9.392377e-06 8.509401e-06 displacement 6.732868e+01 6.986688e+00 3.126166e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 11 step from line search = 0.113081 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 4.143386e-08 0.000000e+00 energy 8.509401e-04 1.071342e-06 8.509401e-06 displacement 6.732868e+01 1.560660e-01 3.151751e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 30 stiffness matrix reformations = 12 step from line search = 0.079328 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 3.519289e-08 0.000000e+00 energy 8.509401e-04 3.186612e-07 8.509401e-06 displacement 6.732868e+01 6.406706e-02 3.163875e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 36 stiffness matrix reformations = 13 step from line search = 0.041511 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 3.230334e-08 0.000000e+00 energy 8.509401e-04 1.739783e-07 8.509401e-06 displacement 6.732868e+01 1.664807e-02 3.170085e-03 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 37 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 2.433502e-08 0.000000e+00 energy 8.509401e-04 1.991751e-06 8.509401e-06 displacement 6.732868e+01 8.918645e+00 3.302349e-03 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 38 stiffness matrix reformations = 15 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 5.972970e-11 0.000000e+00 energy 8.509401e-04 2.884578e-07 8.509401e-06 displacement 6.732868e+01 5.010444e-01 3.291496e-03 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 39 stiffness matrix reformations = 16 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 9.750869e-12 0.000000e+00 energy 8.509401e-04 1.021239e-08 8.509401e-06 displacement 6.732868e+01 6.216587e-02 3.297352e-03 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.489839 stiffness updates = 0 right hand side evaluations = 40 stiffness matrix reformations = 17 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 7.756429e-06 1.145748e-17 0.000000e+00 energy 8.509401e-04 1.962064e-12 8.509401e-06 displacement 6.732868e+01 7.099457e-05 3.296445e-03 ------- converged at time : 0.489839 ]0;(step 1/2: 49%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0493435 ===== beginning time step 13 : 0.539182 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.539182 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.004069e-05 1.048036e-05 0.000000e+00 energy 2.811114e-04 2.435165e-04 2.811114e-06 displacement 4.768864e+00 4.768864e+00 4.768864e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.539182 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.004069e-05 2.983162e-08 0.000000e+00 energy 2.811114e-04 1.065871e-05 2.811114e-06 displacement 4.768864e+00 9.724931e-02 6.137055e-06 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.539182 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.004069e-05 1.771184e-08 0.000000e+00 energy 2.811114e-04 2.680498e-06 2.811114e-06 displacement 4.768864e+00 8.231671e-02 7.480311e-06 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.539182 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.004069e-05 7.676883e-08 0.000000e+00 energy 2.811114e-04 4.113498e-07 2.811114e-06 displacement 4.768864e+00 1.644302e-01 9.674709e-06 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.539182 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.004069e-05 2.968748e-08 0.000000e+00 energy 2.811114e-04 3.048272e-06 2.811114e-06 displacement 4.768864e+00 9.041657e-01 1.617568e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.539182 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.004069e-05 1.876342e-08 0.000000e+00 energy 2.811114e-04 3.391532e-06 2.811114e-06 displacement 4.768864e+00 1.129907e+00 2.554200e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.539182 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.004069e-05 1.679971e-08 0.000000e+00 energy 2.811114e-04 2.278225e-07 2.811114e-06 displacement 4.768864e+00 2.973825e+01 1.077936e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.539182 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.004069e-05 8.849846e-09 0.000000e+00 energy 2.811114e-04 3.656080e-07 2.811114e-06 displacement 4.768864e+00 6.064808e+00 1.452928e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.539182 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.004069e-05 1.467937e-11 0.000000e+00 energy 2.811114e-04 9.751242e-08 2.811114e-06 displacement 4.768864e+00 1.198449e-01 1.459925e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.539182 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.004069e-05 3.867060e-16 0.000000e+00 energy 2.811114e-04 3.576377e-11 2.811114e-06 displacement 4.768864e+00 1.867308e-03 1.464834e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.539182 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.004069e-05 6.775969e-25 0.000000e+00 energy 2.811114e-04 1.392847e-17 2.811114e-06 displacement 4.768864e+00 9.600583e-08 1.464885e-04 ------- converged at time : 0.539182 ]0;(step 1/2: 54%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0578411 ===== beginning time step 14 : 0.597023 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.597023 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.095981e-05 1.368914e-05 0.000000e+00 energy 1.191869e-03 3.448644e-04 1.191869e-05 displacement 9.381946e+01 9.381946e+01 9.381946e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.597023 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.095981e-05 2.373825e-07 0.000000e+00 energy 1.191869e-03 3.832627e-05 1.191869e-05 displacement 9.381946e+01 3.755093e-01 1.054206e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.597023 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.095981e-05 5.119729e-07 0.000000e+00 energy 1.191869e-03 2.858930e-05 1.191869e-05 displacement 9.381946e+01 3.592989e+00 1.429637e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.597023 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.095981e-05 2.924153e-06 0.000000e+00 energy 1.191869e-03 5.179231e-04 1.191869e-05 displacement 9.381946e+01 2.411978e+01 2.732295e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.597023 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.095981e-05 1.418257e-06 0.000000e+00 energy 1.191869e-03 5.165585e-05 1.191869e-05 displacement 9.381946e+01 6.767653e+00 3.590109e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.597023 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.095981e-05 2.535189e-06 0.000000e+00 energy 1.191869e-03 3.304232e-04 1.191869e-05 displacement 9.381946e+01 1.191230e+02 8.420678e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.597023 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.095981e-05 8.141805e-07 0.000000e+00 energy 1.191869e-03 1.442760e-04 1.191869e-05 displacement 9.381946e+01 6.300111e+01 1.350210e-03 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.597023 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 8 step from line search = 0.229815 convergence norms : INITIAL CURRENT REQUIRED residual 1.095981e-05 7.555213e-07 0.000000e+00 energy 1.191869e-03 3.029737e-05 1.191869e-05 displacement 9.381946e+01 2.118940e+01 1.705783e-03 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.597023 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 9 step from line search = 0.575792 convergence norms : INITIAL CURRENT REQUIRED residual 1.095981e-05 2.610630e-07 0.000000e+00 energy 1.191869e-03 7.125978e-05 1.191869e-05 displacement 9.381946e+01 9.012435e+01 2.506111e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.597023 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.095981e-05 6.988011e-07 0.000000e+00 energy 1.191869e-03 1.763584e-05 1.191869e-05 displacement 9.381946e+01 7.639052e+01 3.198983e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.597023 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.095981e-05 2.724025e-09 0.000000e+00 energy 1.191869e-03 2.185976e-06 1.191869e-05 displacement 9.381946e+01 1.113260e+00 3.296789e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.597023 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.095981e-05 3.631987e-11 0.000000e+00 energy 1.191869e-03 8.434557e-08 1.191869e-05 displacement 9.381946e+01 3.325014e-01 3.250694e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.597023 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.095981e-05 1.732558e-17 0.000000e+00 energy 1.191869e-03 1.084873e-12 1.191869e-05 displacement 9.381946e+01 2.900169e-04 3.251027e-03 ------- converged at time : 0.597023 ]0;(step 1/2: 60%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0609681 ===== beginning time step 15 : 0.657991 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.657991 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.411197e-05 1.478524e-05 0.000000e+00 energy 4.172040e-04 3.501099e-04 4.172040e-06 displacement 8.158945e+00 8.158945e+00 8.158945e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.657991 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.411197e-05 3.743600e-08 0.000000e+00 energy 4.172040e-04 1.352478e-05 4.172040e-06 displacement 8.158945e+00 1.385940e-01 1.025860e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.657991 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.411197e-05 2.323276e-08 0.000000e+00 energy 4.172040e-04 3.291450e-06 4.172040e-06 displacement 8.158945e+00 1.074606e-01 1.217799e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.657991 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.411197e-05 1.997679e-07 0.000000e+00 energy 4.172040e-04 1.855774e-06 4.172040e-06 displacement 8.158945e+00 3.224810e-01 1.604770e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.657991 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.411197e-05 6.182905e-08 0.000000e+00 energy 4.172040e-04 5.383856e-06 4.172040e-06 displacement 8.158945e+00 2.890673e+00 3.173123e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.657991 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.411197e-05 2.145093e-08 0.000000e+00 energy 4.172040e-04 1.755013e-06 4.172040e-06 displacement 8.158945e+00 1.812155e-01 3.614874e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.657991 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.411197e-05 1.395753e-08 0.000000e+00 energy 4.172040e-04 1.792204e-06 4.172040e-06 displacement 8.158945e+00 1.318447e+01 9.045871e-05 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.657991 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.411197e-05 5.899326e-09 0.000000e+00 energy 4.172040e-04 5.062458e-06 4.172040e-06 displacement 8.158945e+00 8.029850e+00 1.513157e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.657991 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.411197e-05 1.950146e-09 0.000000e+00 energy 4.172040e-04 1.521412e-06 4.172040e-06 displacement 8.158945e+00 1.306178e+00 1.749725e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.657991 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.411197e-05 3.169572e-11 0.000000e+00 energy 4.172040e-04 5.938391e-08 4.172040e-06 displacement 8.158945e+00 3.904972e-02 1.779392e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.657991 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.411197e-05 1.334755e-17 0.000000e+00 energy 4.172040e-04 1.877487e-12 4.172040e-06 displacement 8.158945e+00 1.997524e-05 1.778339e-04 ------- converged at time : 0.657991 ]0;(step 1/2: 66%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0675156 ===== beginning time step 16 : 0.725507 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.725507 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.549260e-05 1.869480e-05 0.000000e+00 energy 1.448875e-03 4.731672e-04 1.448875e-05 displacement 1.058724e+02 1.058724e+02 1.058724e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.725507 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.549260e-05 2.434770e-07 0.000000e+00 energy 1.448875e-03 4.336194e-05 1.448875e-05 displacement 1.058724e+02 5.397747e-01 1.206027e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.725507 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.549260e-05 6.122352e-07 0.000000e+00 energy 1.448875e-03 2.994223e-05 1.448875e-05 displacement 1.058724e+02 3.361912e+00 1.586655e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 4 step from line search = 0.600017 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 5.945967e-06 0.000000e+00 energy 1.448875e-03 5.974467e-05 1.448875e-05 displacement 1.058724e+02 1.621865e+01 2.652469e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.725507 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.549260e-05 5.655611e-06 0.000000e+00 energy 1.448875e-03 7.008307e-04 1.448875e-05 displacement 1.058724e+02 3.212771e+01 4.697620e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 6 step from line search = 0.521109 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 7.044009e-06 0.000000e+00 energy 1.448875e-03 4.091776e-04 1.448875e-05 displacement 1.058724e+02 5.753192e+00 5.658451e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.725507 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.549260e-05 2.200364e-06 0.000000e+00 energy 1.448875e-03 4.947317e-04 1.448875e-05 displacement 1.058724e+02 3.127836e+01 8.523540e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 8 step from line search = 0.430965 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 4.075027e-06 0.000000e+00 energy 1.448875e-03 2.407222e-04 1.448875e-05 displacement 1.058724e+02 5.410496e+00 9.593726e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 9 step from line search = 0.113991 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 3.243962e-06 0.000000e+00 energy 1.448875e-03 2.247123e-05 1.448875e-05 displacement 1.058724e+02 1.664588e+00 1.039156e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 10 step from line search = 0.049989 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 2.929181e-06 0.000000e+00 energy 1.448875e-03 5.555783e-06 1.448875e-05 displacement 1.058724e+02 2.377753e-01 1.069990e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 26 stiffness matrix reformations = 11 step from line search = 0.034406 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 2.731482e-06 0.000000e+00 energy 1.448875e-03 2.948895e-06 1.448875e-05 displacement 1.058724e+02 9.951599e-02 1.090104e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 32 stiffness matrix reformations = 12 step from line search = 0.034104 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 2.550909e-06 0.000000e+00 energy 1.448875e-03 2.458466e-06 1.448875e-05 displacement 1.058724e+02 8.989030e-02 1.109355e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 38 stiffness matrix reformations = 13 step from line search = 0.025485 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 2.423524e-06 0.000000e+00 energy 1.448875e-03 1.378647e-06 1.448875e-05 displacement 1.058724e+02 4.904399e-02 1.123699e-03 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 43 stiffness matrix reformations = 14 step from line search = 0.500000 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 1.536952e-06 0.000000e+00 energy 1.448875e-03 2.269157e-04 1.448875e-05 displacement 1.058724e+02 1.697335e+01 1.406626e-03 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.725507 stiffness updates = 0 right hand side evaluations = 44 stiffness matrix reformations = 15 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.549260e-05 1.085014e-06 0.000000e+00 energy 1.448875e-03 1.693303e-04 1.448875e-05 displacement 1.058724e+02 3.417402e+01 1.836910e-03 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 ************************************************************************* * ERROR * * * * Negative jacobian was detected. * ************************************************************************* ------- failed to converge at time : 0.725507 Retrying time step. Retry attempt 1 of max 25 AUTO STEPPER: retry step, dt = 0.0649189 ===== beginning time step 16 : 0.72291 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.72291 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.548114e-05 1.859134e-05 0.000000e+00 energy 1.396197e-03 4.690701e-04 1.396197e-05 displacement 1.006921e+02 1.006921e+02 1.006921e-04 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.72291 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.548114e-05 2.326632e-07 0.000000e+00 energy 1.396197e-03 4.210138e-05 1.396197e-05 displacement 1.006921e+02 5.163172e-01 1.147345e-04 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.72291 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.548114e-05 5.821872e-07 0.000000e+00 energy 1.396197e-03 2.897499e-05 1.396197e-05 displacement 1.006921e+02 3.181837e+00 1.508331e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 6 stiffness matrix reformations = 4 step from line search = 0.586003 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 6.645806e-06 0.000000e+00 energy 1.396197e-03 7.957603e-05 1.396197e-05 displacement 1.006921e+02 1.344666e+01 2.436264e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.72291 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.548114e-05 4.197657e-06 0.000000e+00 energy 1.396197e-03 4.697991e-04 1.396197e-05 displacement 1.006921e+02 2.824491e+01 4.262399e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 6 step from line search = 0.565298 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 4.094598e-06 0.000000e+00 energy 1.396197e-03 3.078068e-04 1.396197e-05 displacement 1.006921e+02 1.855931e+01 6.114796e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 7 step from line search = 0.465501 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 1.783774e-06 0.000000e+00 energy 1.396197e-03 9.089101e-05 1.396197e-05 displacement 1.006921e+02 1.457459e+01 7.911445e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 8 step from line search = 0.282114 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 1.263130e-06 0.000000e+00 energy 1.396197e-03 2.065702e-05 1.396197e-05 displacement 1.006921e+02 6.925483e+00 9.354773e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 0.510684 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 5.760330e-07 0.000000e+00 energy 1.396197e-03 1.775611e-05 1.396197e-05 displacement 1.006921e+02 9.758533e+00 1.123272e-03 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 10 step from line search = 0.180388 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 4.449155e-07 0.000000e+00 energy 1.396197e-03 1.211665e-05 1.396197e-05 displacement 1.006921e+02 5.244859e-01 1.167031e-03 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 11 step from line search = 0.426433 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 4.686796e-07 0.000000e+00 energy 1.396197e-03 4.603488e-06 1.396197e-05 displacement 1.006921e+02 9.218590e+00 1.375793e-03 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 12 step from line search = 0.516765 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 2.835627e-07 0.000000e+00 energy 1.396197e-03 5.495092e-06 1.396197e-05 displacement 1.006921e+02 5.483265e+00 1.520568e-03 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 13 step from line search = 0.302186 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 2.987251e-07 0.000000e+00 energy 1.396197e-03 1.511141e-06 1.396197e-05 displacement 1.006921e+02 1.031775e+00 1.589781e-03 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 25 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 3.733909e-07 0.000000e+00 energy 1.396197e-03 3.997846e-05 1.396197e-05 displacement 1.006921e+02 7.797778e+00 1.808797e-03 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 26 stiffness matrix reformations = 15 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 8.468814e-07 0.000000e+00 energy 1.396197e-03 1.424063e-04 1.396197e-05 displacement 1.006921e+02 5.530902e+00 1.950564e-03 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 32 stiffness matrix reformations = 16 step from line search = 0.046520 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 7.712528e-07 0.000000e+00 energy 1.396197e-03 1.859479e-06 1.396197e-05 displacement 1.006921e+02 5.536533e-02 1.970409e-03 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 33 stiffness matrix reformations = 17 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 3.365232e-07 0.000000e+00 energy 1.396197e-03 1.766414e-05 1.396197e-05 displacement 1.006921e+02 2.951654e+01 2.457411e-03 Reforming stiffness matrix: reformation #18 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 18 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 34 stiffness matrix reformations = 18 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 2.255043e-07 0.000000e+00 energy 1.396197e-03 2.881705e-05 1.396197e-05 displacement 1.006921e+02 3.820802e+00 2.515169e-03 Reforming stiffness matrix: reformation #19 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 19 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 35 stiffness matrix reformations = 19 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 7.404215e-10 0.000000e+00 energy 1.396197e-03 2.407805e-06 1.396197e-05 displacement 1.006921e+02 6.351196e-01 2.442991e-03 Reforming stiffness matrix: reformation #20 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 20 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 36 stiffness matrix reformations = 20 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 2.174657e-11 0.000000e+00 energy 1.396197e-03 9.165736e-09 1.396197e-05 displacement 1.006921e+02 1.527834e-02 2.436938e-03 Reforming stiffness matrix: reformation #21 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 21 Nonlinear solution status: time= 0.72291 stiffness updates = 0 right hand side evaluations = 37 stiffness matrix reformations = 21 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.548114e-05 2.485749e-16 0.000000e+00 energy 1.396197e-03 6.484557e-12 1.396197e-05 displacement 1.006921e+02 2.700672e-04 2.435422e-03 ------- converged at time : 0.72291 ]0;(step 1/2: 72%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0548819 ===== beginning time step 17 : 0.777792 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.777792 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.944801e-05 2.002676e-05 0.000000e+00 energy 5.572578e-04 4.988101e-04 5.572578e-06 displacement 7.087511e+00 7.087511e+00 7.087511e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.777792 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.944801e-05 2.986032e-08 0.000000e+00 energy 5.572578e-04 1.390073e-05 5.572578e-06 displacement 7.087511e+00 1.651722e-01 9.232481e-06 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.777792 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.944801e-05 2.960886e-08 0.000000e+00 energy 5.572578e-04 3.811835e-06 5.572578e-06 displacement 7.087511e+00 1.144622e-01 1.113094e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.777792 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.944801e-05 2.977689e-08 0.000000e+00 energy 5.572578e-04 3.952503e-06 5.572578e-06 displacement 7.087511e+00 3.069797e-01 1.485830e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.777792 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.944801e-05 3.637317e-08 0.000000e+00 energy 5.572578e-04 1.079078e-06 5.572578e-06 displacement 7.087511e+00 1.586915e+00 2.530658e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.777792 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.944801e-05 3.722753e-08 0.000000e+00 energy 5.572578e-04 9.835170e-07 5.572578e-06 displacement 7.087511e+00 8.587364e-01 3.437527e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.777792 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.944801e-05 6.201296e-08 0.000000e+00 energy 5.572578e-04 6.928887e-06 5.572578e-06 displacement 7.087511e+00 1.345048e+00 4.848352e-05 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.777792 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.944801e-05 3.681354e-09 0.000000e+00 energy 5.572578e-04 1.832608e-06 5.572578e-06 displacement 7.087511e+00 1.146974e+00 6.409397e-05 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.777792 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.944801e-05 1.261520e-09 0.000000e+00 energy 5.572578e-04 8.400740e-07 5.572578e-06 displacement 7.087511e+00 5.495623e-01 7.606896e-05 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.777792 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.944801e-05 6.149355e-11 0.000000e+00 energy 5.572578e-04 3.316870e-07 5.572578e-06 displacement 7.087511e+00 3.793013e-01 8.692186e-05 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.777792 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.944801e-05 8.634344e-13 0.000000e+00 energy 5.572578e-04 1.200136e-08 5.572578e-06 displacement 7.087511e+00 2.913552e-02 8.998566e-05 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.777792 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 1.944801e-05 1.139562e-18 0.000000e+00 energy 5.572578e-04 4.944222e-13 5.572578e-06 displacement 7.087511e+00 3.115899e-05 9.008444e-05 ------- converged at time : 0.777792 ]0;(step 1/2: 78%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 0.0602074 ===== beginning time step 18 : 0.838 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.838 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.077423e-05 2.383779e-05 0.000000e+00 energy 1.350586e-03 6.156479e-04 1.350586e-05 displacement 8.292556e+01 8.292556e+01 8.292556e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.838 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.077423e-05 1.936195e-07 0.000000e+00 energy 1.350586e-03 4.229050e-05 1.350586e-05 displacement 8.292556e+01 4.986658e-01 9.548337e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.838 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.077423e-05 5.927324e-07 0.000000e+00 energy 1.350586e-03 3.655059e-05 1.350586e-05 displacement 8.292556e+01 2.608494e+00 1.252729e-04 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.838 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.077423e-05 2.611329e-06 0.000000e+00 energy 1.350586e-03 4.443736e-04 1.350586e-05 displacement 8.292556e+01 2.606909e+01 2.536340e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 5 step from line search = 0.546207 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 4.954075e-06 0.000000e+00 energy 1.350586e-03 1.019442e-05 1.350586e-05 displacement 8.292556e+01 6.975372e-01 2.630562e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.838 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.077423e-05 4.482752e-06 0.000000e+00 energy 1.350586e-03 3.346782e-04 1.350586e-05 displacement 8.292556e+01 7.670670e+00 3.505000e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.838 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.077423e-05 1.052640e-05 0.000000e+00 energy 1.350586e-03 9.404954e-04 1.350586e-05 displacement 8.292556e+01 2.712002e+01 5.522818e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 8 step from line search = 0.394033 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 3.295834e-06 0.000000e+00 energy 1.350586e-03 6.264967e-05 1.350586e-05 displacement 8.292556e+01 1.984831e+00 6.099935e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 6.531125e-07 0.000000e+00 energy 1.350586e-03 6.666939e-06 1.350586e-05 displacement 8.292556e+01 1.991598e+00 6.587914e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 10 step from line search = 0.570757 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 5.237759e-07 0.000000e+00 energy 1.350586e-03 1.682962e-05 1.350586e-05 displacement 8.292556e+01 2.160851e+00 7.254185e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 11 step from line search = 0.363641 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 3.545322e-07 0.000000e+00 energy 1.350586e-03 4.030945e-06 1.350586e-05 displacement 8.292556e+01 9.302561e-01 7.490214e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 1.596855e-07 0.000000e+00 energy 1.350586e-03 2.919184e-05 1.350586e-05 displacement 8.292556e+01 6.674172e+00 8.801601e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 7.231712e-07 0.000000e+00 energy 1.350586e-03 2.029815e-05 1.350586e-05 displacement 8.292556e+01 1.351665e+00 8.822306e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 14 step from line search = 0.586046 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 1.910914e-07 0.000000e+00 energy 1.350586e-03 2.198619e-06 1.350586e-05 displacement 8.292556e+01 1.278308e+00 9.471141e-04 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 23 stiffness matrix reformations = 15 step from line search = 0.261200 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 7.577434e-08 0.000000e+00 energy 1.350586e-03 7.467468e-06 1.350586e-05 displacement 8.292556e+01 6.711871e-01 9.961060e-04 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 16 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 2.792841e-08 0.000000e+00 energy 1.350586e-03 1.901401e-06 1.350586e-05 displacement 8.292556e+01 5.938733e+00 1.134856e-03 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 25 stiffness matrix reformations = 17 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 1.224562e-09 0.000000e+00 energy 1.350586e-03 1.383988e-07 1.350586e-05 displacement 8.292556e+01 7.267499e-01 1.170041e-03 Reforming stiffness matrix: reformation #18 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 18 Nonlinear solution status: time= 0.838 stiffness updates = 0 right hand side evaluations = 26 stiffness matrix reformations = 18 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.077423e-05 1.047359e-13 0.000000e+00 energy 1.350586e-03 1.673934e-09 1.350586e-05 displacement 8.292556e+01 8.252095e-04 1.171018e-03 ------- converged at time : 0.838 ]0;(step 1/2: 84%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0549703 ===== beginning time step 19 : 0.89297 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.89297 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.503534e-05 2.600896e-05 0.000000e+00 energy 8.369793e-04 7.207204e-04 8.369793e-06 displacement 1.465998e+01 1.465998e+01 1.465998e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.89297 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.503534e-05 7.670217e-08 0.000000e+00 energy 8.369793e-04 2.918095e-05 8.369793e-06 displacement 1.465998e+01 3.406741e-01 1.916060e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.89297 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.503534e-05 7.115015e-08 0.000000e+00 energy 8.369793e-04 6.543352e-06 8.369793e-06 displacement 1.465998e+01 4.508853e-01 2.477278e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.89297 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.503534e-05 1.353426e-07 0.000000e+00 energy 8.369793e-04 1.024137e-05 8.369793e-06 displacement 1.465998e+01 1.070843e+00 3.457656e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.89297 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.503534e-05 3.741091e-07 0.000000e+00 energy 8.369793e-04 1.475915e-05 8.369793e-06 displacement 1.465998e+01 1.732706e+00 4.995554e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 6 step from line search = 0.456276 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 5.956767e-07 0.000000e+00 energy 8.369793e-04 9.983706e-06 8.369793e-06 displacement 1.465998e+01 4.848325e-01 5.867654e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 7 step from line search = 0.618196 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 4.357437e-07 0.000000e+00 energy 8.369793e-04 1.952434e-05 8.369793e-06 displacement 1.465998e+01 5.705697e-01 6.962079e-05 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 2.241135e-07 0.000000e+00 energy 8.369793e-04 5.005303e-05 8.369793e-06 displacement 1.465998e+01 1.954621e+00 9.304786e-05 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 9 step from line search = 0.264634 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 1.642881e-07 0.000000e+00 energy 8.369793e-04 6.929354e-06 8.369793e-06 displacement 1.465998e+01 3.527497e-02 9.044754e-05 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 4.464035e-08 0.000000e+00 energy 8.369793e-04 3.657062e-06 8.369793e-06 displacement 1.465998e+01 1.514537e-01 9.190628e-05 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 11 step from line search = 0.323098 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 2.170167e-08 0.000000e+00 energy 8.369793e-04 2.744188e-06 8.369793e-06 displacement 1.465998e+01 3.143375e-02 8.968910e-05 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 12 step from line search = 0.402795 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 9.916260e-09 0.000000e+00 energy 8.369793e-04 8.080745e-07 8.369793e-06 displacement 1.465998e+01 4.780255e-03 8.936889e-05 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 9.716665e-09 0.000000e+00 energy 8.369793e-04 1.552381e-06 8.369793e-06 displacement 1.465998e+01 1.574980e-02 9.027631e-05 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 1.759069e-09 0.000000e+00 energy 8.369793e-04 1.088821e-06 8.369793e-06 displacement 1.465998e+01 1.607691e-02 9.111654e-05 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 23 stiffness matrix reformations = 15 step from line search = 0.343101 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 6.659468e-10 0.000000e+00 energy 8.369793e-04 2.817055e-07 8.369793e-06 displacement 1.465998e+01 1.138884e-03 9.108631e-05 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 25 stiffness matrix reformations = 16 step from line search = 0.343360 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 2.230519e-10 0.000000e+00 energy 8.369793e-04 8.286917e-08 8.369793e-06 displacement 1.465998e+01 2.654019e-04 9.118154e-05 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.89297 stiffness updates = 0 right hand side evaluations = 27 stiffness matrix reformations = 17 step from line search = 0.273672 convergence norms : INITIAL CURRENT REQUIRED residual 2.503534e-05 5.622533e-11 0.000000e+00 energy 8.369793e-04 2.380225e-08 8.369793e-06 displacement 1.465998e+01 6.492273e-05 9.123063e-05 ------- converged at time : 0.89297 ]0;(step 1/2: 89%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0516417 ===== beginning time step 20 : 0.944612 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.944612 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.827914e-05 3.038275e-05 0.000000e+00 energy 1.338519e-03 9.015139e-04 1.338519e-05 displacement 5.218461e+01 5.218461e+01 5.218461e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.944612 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.827914e-05 1.946903e-07 0.000000e+00 energy 1.338519e-03 5.044388e-05 1.338519e-05 displacement 5.218461e+01 6.526499e-01 6.381441e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 3 step from line search = 0.587997 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 2.163410e-06 0.000000e+00 energy 1.338519e-03 1.253953e-05 1.338519e-05 displacement 5.218461e+01 9.281410e-01 7.760472e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.944612 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.827914e-05 1.790441e-06 0.000000e+00 energy 1.338519e-03 2.412054e-04 1.338519e-05 displacement 5.218461e+01 1.114354e+01 1.407062e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 5 step from line search = 0.611779 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 7.215706e-07 0.000000e+00 energy 1.338519e-03 1.622409e-05 1.338519e-05 displacement 5.218461e+01 3.080958e+00 1.713554e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 6 step from line search = 0.592461 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 8.155502e-07 0.000000e+00 energy 1.338519e-03 2.031203e-05 1.338519e-05 displacement 5.218461e+01 1.041890e+00 1.945025e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 7 step from line search = 0.473345 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 1.071973e-06 0.000000e+00 energy 1.338519e-03 5.373909e-05 1.338519e-05 displacement 5.218461e+01 1.805497e+00 2.232341e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 1.133125e-06 0.000000e+00 energy 1.338519e-03 8.304416e-05 1.338519e-05 displacement 5.218461e+01 1.233107e+00 2.486879e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 1.528929e-06 0.000000e+00 energy 1.338519e-03 2.810004e-04 1.338519e-05 displacement 5.218461e+01 5.058001e+00 3.178813e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 3.383234e-07 0.000000e+00 energy 1.338519e-03 6.082783e-05 1.338519e-05 displacement 5.218461e+01 1.141985e+00 3.456536e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 11 step from line search = 0.484293 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 7.243163e-08 0.000000e+00 energy 1.338519e-03 3.375301e-06 1.338519e-05 displacement 5.218461e+01 8.280471e-02 3.465050e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 12 step from line search = 0.518982 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 4.380693e-08 0.000000e+00 energy 1.338519e-03 1.088105e-06 1.338519e-05 displacement 5.218461e+01 2.843032e-01 3.654175e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 5.448855e-08 0.000000e+00 energy 1.338519e-03 6.524306e-07 1.338519e-05 displacement 5.218461e+01 6.764564e-01 3.956391e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 26 stiffness matrix reformations = 14 step from line search = 0.073905 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 7.316739e-08 0.000000e+00 energy 1.338519e-03 1.111832e-06 1.338519e-05 displacement 5.218461e+01 3.389532e-03 3.975393e-04 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 29 stiffness matrix reformations = 15 step from line search = 0.389146 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 9.067340e-08 0.000000e+00 energy 1.338519e-03 3.692248e-06 1.338519e-05 displacement 5.218461e+01 4.223549e-02 3.979393e-04 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 32 stiffness matrix reformations = 16 step from line search = 0.279293 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 4.728038e-08 0.000000e+00 energy 1.338519e-03 4.228697e-06 1.338519e-05 displacement 5.218461e+01 7.039366e-02 4.061645e-04 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 35 stiffness matrix reformations = 17 step from line search = 0.367998 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 4.805314e-08 0.000000e+00 energy 1.338519e-03 1.512477e-06 1.338519e-05 displacement 5.218461e+01 1.405197e-02 4.076703e-04 Reforming stiffness matrix: reformation #18 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 18 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 40 stiffness matrix reformations = 18 step from line search = 0.042303 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 2.522136e-08 0.000000e+00 energy 1.338519e-03 3.147327e-07 1.338519e-05 displacement 5.218461e+01 7.938246e-04 4.084518e-04 Reforming stiffness matrix: reformation #19 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 19 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 46 stiffness matrix reformations = 19 step from line search = 0.500000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 2.608577e-07 0.000000e+00 energy 1.338519e-03 1.987362e-05 1.338519e-05 displacement 5.218461e+01 2.974041e-02 4.128554e-04 Reforming stiffness matrix: reformation #20 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 20 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 47 stiffness matrix reformations = 20 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 1.068825e-07 0.000000e+00 energy 1.338519e-03 4.894854e-05 1.338519e-05 displacement 5.218461e+01 9.661851e-01 4.400130e-04 Reforming stiffness matrix: reformation #21 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 21 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 49 stiffness matrix reformations = 21 step from line search = 0.547093 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 4.419538e-08 0.000000e+00 energy 1.338519e-03 6.169805e-06 1.338519e-05 displacement 5.218461e+01 5.986425e-01 4.166958e-04 Reforming stiffness matrix: reformation #22 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 22 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 50 stiffness matrix reformations = 22 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 4.475559e-08 0.000000e+00 energy 1.338519e-03 4.741280e-07 1.338519e-05 displacement 5.218461e+01 8.161517e-02 4.092477e-04 Reforming stiffness matrix: reformation #23 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 23 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 51 stiffness matrix reformations = 23 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 2.263975e-08 0.000000e+00 energy 1.338519e-03 3.164546e-06 1.338519e-05 displacement 5.218461e+01 2.722143e-01 4.088448e-04 Reforming stiffness matrix: reformation #24 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 24 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 52 stiffness matrix reformations = 24 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 1.828963e-09 0.000000e+00 energy 1.338519e-03 2.122428e-07 1.338519e-05 displacement 5.218461e+01 6.446049e-02 4.136758e-04 Reforming stiffness matrix: reformation #25 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 25 Nonlinear solution status: time= 0.944612 stiffness updates = 0 right hand side evaluations = 53 stiffness matrix reformations = 25 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.827914e-05 4.321856e-09 0.000000e+00 energy 1.338519e-03 1.048519e-06 1.338519e-05 displacement 5.218461e+01 4.449527e-01 4.352878e-04 Reforming stiffness matrix: reformation #26 ************************************************************************* * ERROR * * * * Max nr of reformations reached. * ************************************************************************* ------- failed to converge at time : 0.944612 Retrying time step. Retry attempt 1 of max 25 AUTO STEPPER: retry step, dt = 0.0496555 ===== beginning time step 20 : 0.942625 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.942625 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.826801e-05 3.027705e-05 0.000000e+00 energy 1.308182e-03 8.974595e-04 1.308182e-05 displacement 4.906145e+01 4.906145e+01 4.906145e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.942625 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.826801e-05 1.865288e-07 0.000000e+00 energy 1.308182e-03 4.920581e-05 1.308182e-05 displacement 4.906145e+01 6.307383e-01 6.014775e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 3 step from line search = 0.603428 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 2.030990e-06 0.000000e+00 energy 1.308182e-03 1.099298e-05 1.308182e-05 displacement 4.906145e+01 9.272881e-01 7.359337e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.942625 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.826801e-05 1.593101e-06 0.000000e+00 energy 1.308182e-03 2.136366e-04 1.308182e-05 displacement 4.906145e+01 1.031704e+01 1.326309e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 5 step from line search = 0.626097 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 6.145299e-07 0.000000e+00 energy 1.308182e-03 1.457286e-05 1.308182e-05 displacement 4.906145e+01 3.030977e+00 1.629868e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 6 step from line search = 0.596194 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 7.108561e-07 0.000000e+00 energy 1.308182e-03 1.758554e-05 1.308182e-05 displacement 4.906145e+01 9.573299e-01 1.846114e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 7 step from line search = 0.542940 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 9.780140e-07 0.000000e+00 energy 1.308182e-03 3.145760e-05 1.308182e-05 displacement 4.906145e+01 1.679188e+00 2.146706e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 8 step from line search = 0.606561 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 6.795386e-07 0.000000e+00 energy 1.308182e-03 4.188634e-05 1.308182e-05 displacement 4.906145e+01 5.219953e-01 2.246021e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 9.753815e-07 0.000000e+00 energy 1.308182e-03 1.511937e-04 1.308182e-05 displacement 4.906145e+01 5.817224e+00 2.956128e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 0.629751 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 8.676322e-07 0.000000e+00 energy 1.308182e-03 1.260202e-04 1.308182e-05 displacement 4.906145e+01 8.829311e-01 2.814560e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 11 step from line search = 0.623889 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 6.011059e-07 0.000000e+00 energy 1.308182e-03 5.961591e-05 1.308182e-05 displacement 4.906145e+01 2.399722e-01 2.885602e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 5.221751e-07 0.000000e+00 energy 1.308182e-03 1.099340e-04 1.308182e-05 displacement 4.906145e+01 2.646824e+00 3.289567e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 4.637252e-07 0.000000e+00 energy 1.308182e-03 1.438353e-04 1.308182e-05 displacement 4.906145e+01 2.965110e+00 3.657453e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 5.285259e-07 0.000000e+00 energy 1.308182e-03 1.167946e-04 1.308182e-05 displacement 4.906145e+01 2.575604e+00 3.933067e-04 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 25 stiffness matrix reformations = 15 step from line search = 0.250607 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 3.818386e-07 0.000000e+00 energy 1.308182e-03 5.140555e-06 1.308182e-05 displacement 4.906145e+01 1.200647e-01 3.892493e-04 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 27 stiffness matrix reformations = 16 step from line search = 0.451598 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 1.669806e-07 0.000000e+00 energy 1.308182e-03 1.096337e-05 1.308182e-05 displacement 4.906145e+01 6.317648e-02 3.823257e-04 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 29 stiffness matrix reformations = 17 step from line search = 0.587301 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 2.491194e-07 0.000000e+00 energy 1.308182e-03 1.550001e-05 1.308182e-05 displacement 4.906145e+01 3.203702e-02 3.859978e-04 Reforming stiffness matrix: reformation #18 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 18 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 30 stiffness matrix reformations = 18 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 2.625877e-07 0.000000e+00 energy 1.308182e-03 4.551221e-05 1.308182e-05 displacement 4.906145e+01 4.504398e-01 4.081412e-04 Reforming stiffness matrix: reformation #19 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 19 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 32 stiffness matrix reformations = 19 step from line search = 0.329300 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 1.182865e-07 0.000000e+00 energy 1.308182e-03 1.469559e-06 1.308182e-05 displacement 4.906145e+01 5.966313e-02 4.066305e-04 Reforming stiffness matrix: reformation #20 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 20 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 33 stiffness matrix reformations = 20 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 1.746107e-07 0.000000e+00 energy 1.308182e-03 2.262122e-05 1.308182e-05 displacement 4.906145e+01 1.483355e-01 3.942734e-04 Reforming stiffness matrix: reformation #21 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 21 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 35 stiffness matrix reformations = 21 step from line search = 0.635643 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 7.494595e-08 0.000000e+00 energy 1.308182e-03 1.983578e-05 1.308182e-05 displacement 4.906145e+01 1.735541e-01 3.976247e-04 Reforming stiffness matrix: reformation #22 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 22 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 37 stiffness matrix reformations = 22 step from line search = 0.563364 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 2.084263e-08 0.000000e+00 energy 1.308182e-03 5.594459e-06 1.308182e-05 displacement 4.906145e+01 6.098309e-02 4.011696e-04 Reforming stiffness matrix: reformation #23 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 23 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 38 stiffness matrix reformations = 23 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 1.236279e-08 0.000000e+00 energy 1.308182e-03 1.195645e-06 1.308182e-05 displacement 4.906145e+01 6.279176e-02 4.093644e-04 Reforming stiffness matrix: reformation #24 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 24 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 39 stiffness matrix reformations = 24 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 2.664560e-09 0.000000e+00 energy 1.308182e-03 4.236915e-07 1.308182e-05 displacement 4.906145e+01 1.592512e-02 4.141183e-04 Reforming stiffness matrix: reformation #25 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 25 Nonlinear solution status: time= 0.942625 stiffness updates = 0 right hand side evaluations = 40 stiffness matrix reformations = 25 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.826801e-05 6.882496e-10 0.000000e+00 energy 1.308182e-03 1.457320e-07 1.308182e-05 displacement 4.906145e+01 9.778674e-03 4.152669e-04 Reforming stiffness matrix: reformation #26 ************************************************************************* * ERROR * * * * Max nr of reformations reached. * ************************************************************************* ------- failed to converge at time : 0.942625 Retrying time step. Retry attempt 2 of max 25 AUTO STEPPER: retry step, dt = 0.0476692 ===== beginning time step 20 : 0.940639 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.940639 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.825687e-05 3.017098e-05 0.000000e+00 energy 1.278606e-03 8.934382e-04 1.278606e-05 displacement 4.601876e+01 4.601876e+01 4.601876e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.940639 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.825687e-05 1.785401e-07 0.000000e+00 energy 1.278606e-03 4.810758e-05 1.278606e-05 displacement 4.601876e+01 6.088468e-01 5.656810e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 3 step from line search = 0.618762 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 1.892952e-06 0.000000e+00 energy 1.278606e-03 9.713337e-06 1.278606e-05 displacement 4.601876e+01 9.122936e-01 6.956357e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.940639 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.825687e-05 1.435096e-06 0.000000e+00 energy 1.278606e-03 1.935345e-04 1.278606e-05 displacement 4.601876e+01 9.623553e+00 1.249360e-04 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 5 step from line search = 0.533862 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 1.156466e-06 0.000000e+00 energy 1.278606e-03 3.841899e-05 1.278606e-05 displacement 4.601876e+01 1.797343e+00 1.446610e-04 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 6 step from line search = 0.632013 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 9.084691e-07 0.000000e+00 energy 1.278606e-03 1.145977e-04 1.278606e-05 displacement 4.601876e+01 1.751051e+00 1.726350e-04 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 7 step from line search = 0.528459 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 8.631050e-07 0.000000e+00 energy 1.278606e-03 6.034097e-05 1.278606e-05 displacement 4.601876e+01 1.573749e+00 2.010495e-04 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 8 step from line search = 0.590452 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 5.016148e-07 0.000000e+00 energy 1.278606e-03 5.782395e-05 1.278606e-05 displacement 4.601876e+01 1.133499e+00 2.263736e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 9 step from line search = 0.599735 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 3.802188e-07 0.000000e+00 energy 1.278606e-03 4.276005e-05 1.278606e-05 displacement 4.601876e+01 7.274465e-01 2.476975e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 5.078105e-07 0.000000e+00 energy 1.278606e-03 9.419595e-05 1.278606e-05 displacement 4.601876e+01 2.426209e+00 2.924193e-04 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 11 step from line search = 0.278051 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 2.475907e-07 0.000000e+00 energy 1.278606e-03 3.215053e-06 1.278606e-05 displacement 4.601876e+01 1.891361e-01 3.021647e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 5.998626e-08 0.000000e+00 energy 1.278606e-03 1.134769e-05 1.278606e-05 displacement 4.601876e+01 1.003876e+00 3.351105e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 1.324918e-08 0.000000e+00 energy 1.278606e-03 1.714460e-07 1.278606e-05 displacement 4.601876e+01 2.238229e-01 3.517472e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 2.135860e-09 0.000000e+00 energy 1.278606e-03 2.082001e-06 1.278606e-05 displacement 4.601876e+01 1.777892e-01 3.671759e-04 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 15 step from line search = 0.480036 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 9.871347e-10 0.000000e+00 energy 1.278606e-03 9.262437e-07 1.278606e-05 displacement 4.601876e+01 1.625813e-01 3.795468e-04 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 25 stiffness matrix reformations = 16 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 2.066874e-10 0.000000e+00 energy 1.278606e-03 2.183864e-07 1.278606e-05 displacement 4.601876e+01 1.123093e-01 3.909675e-04 Reforming stiffness matrix: reformation #17 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 17 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 26 stiffness matrix reformations = 17 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 6.089340e-13 0.000000e+00 energy 1.278606e-03 4.847910e-09 1.278606e-05 displacement 4.601876e+01 2.205984e-03 3.924583e-04 Reforming stiffness matrix: reformation #18 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 18 Nonlinear solution status: time= 0.940639 stiffness updates = 0 right hand side evaluations = 27 stiffness matrix reformations = 18 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 2.825687e-05 1.410145e-17 0.000000e+00 energy 1.278606e-03 1.535620e-12 1.278606e-05 displacement 4.601876e+01 1.701132e-05 3.925932e-04 ------- converged at time : 0.940639 ]0;(step 1/2: 94%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0435246 ===== beginning time step 21 : 0.984164 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 2 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 3.242517e-05 0.000000e+00 energy 1.156267e-03 9.991323e-04 1.156267e-05 displacement 1.827854e+01 1.827854e+01 1.827854e-05 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 3 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 1.245011e-07 0.000000e+00 energy 1.156267e-03 3.430247e-05 1.156267e-05 displacement 1.827854e+01 3.547796e-01 2.324522e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 4 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 1.144737e-07 0.000000e+00 energy 1.156267e-03 6.805638e-06 1.156267e-05 displacement 1.827854e+01 1.071514e+00 3.317560e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 5 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 1.964257e-07 0.000000e+00 energy 1.156267e-03 1.211921e-05 1.156267e-05 displacement 1.827854e+01 5.997619e-01 4.082411e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 5 step from line search = 0.513987 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 1.356574e-07 0.000000e+00 energy 1.156267e-03 1.626922e-05 1.156267e-05 displacement 1.827854e+01 3.862185e-01 4.704563e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 6 step from line search = 0.588064 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 5.354827e-07 0.000000e+00 energy 1.156267e-03 2.027063e-05 1.156267e-05 displacement 1.827854e+01 4.689898e-01 5.547490e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 6.971251e-07 0.000000e+00 energy 1.156267e-03 8.684395e-05 1.156267e-05 displacement 1.827854e+01 3.600494e+00 8.529283e-05 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 8 step from line search = 0.582717 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 1.533808e-06 0.000000e+00 energy 1.156267e-03 8.017888e-05 1.156267e-05 displacement 1.827854e+01 1.512497e+00 1.031516e-04 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 0.191366 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 6.918749e-07 0.000000e+00 energy 1.156267e-03 3.273714e-05 1.156267e-05 displacement 1.827854e+01 1.123882e-01 1.022573e-04 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 3.971377e-07 0.000000e+00 energy 1.156267e-03 1.076341e-04 1.156267e-05 displacement 1.827854e+01 1.102121e+00 8.613073e-05 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 6.771105e-08 0.000000e+00 energy 1.156267e-03 2.933200e-05 1.156267e-05 displacement 1.827854e+01 1.200654e+00 1.052868e-04 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 7.806536e-08 0.000000e+00 energy 1.156267e-03 8.072017e-06 1.156267e-05 displacement 1.827854e+01 6.496575e-02 1.071790e-04 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 2.506926e-08 0.000000e+00 energy 1.156267e-03 8.576412e-06 1.156267e-05 displacement 1.827854e+01 5.496904e-02 1.040493e-04 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 3.344406e-09 0.000000e+00 energy 1.156267e-03 8.796923e-07 1.156267e-05 displacement 1.827854e+01 1.154006e-02 1.050632e-04 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 15 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 6.011526e-12 0.000000e+00 energy 1.156267e-03 1.917602e-08 1.156267e-05 displacement 1.827854e+01 2.185990e-03 1.045906e-04 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 0.984164 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 16 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.156265e-05 8.842643e-18 0.000000e+00 energy 1.156267e-03 1.690148e-14 1.156267e-05 displacement 1.827854e+01 4.501663e-06 1.046129e-04 ------- converged at time : 0.984164 ]0;(step 1/2: 98%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 0.0421457 MUST POINT CONTROLLER: adjusting time step. dt = 0.0158362 ===== beginning time step 22 : 1 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 3.176500e-05 0.000000e+00 energy 1.039708e-03 1.008631e-03 1.039708e-05 displacement 5.444220e-01 5.444220e-01 5.444220e-07 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 9.838962e-08 0.000000e+00 energy 1.039708e-03 1.934399e-05 1.039708e-05 displacement 5.444220e-01 2.301979e-01 1.460413e-06 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 5.494830e-08 0.000000e+00 energy 1.039708e-03 2.730277e-06 1.039708e-05 displacement 5.444220e-01 2.591020e-01 2.676863e-06 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 4.248527e-08 0.000000e+00 energy 1.039708e-03 6.898369e-07 1.039708e-05 displacement 5.444220e-01 3.995136e-01 4.835613e-06 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 5 step from line search = 0.608333 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 2.470438e-08 0.000000e+00 energy 1.039708e-03 1.184179e-07 1.039708e-05 displacement 5.444220e-01 2.807505e-02 5.367364e-06 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 7.838794e-09 0.000000e+00 energy 1.039708e-03 1.506969e-07 1.039708e-05 displacement 5.444220e-01 5.649893e-02 6.302761e-06 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 6.489854e-09 0.000000e+00 energy 1.039708e-03 2.157067e-07 1.039708e-05 displacement 5.444220e-01 1.829856e-02 6.836180e-06 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 3.809686e-09 0.000000e+00 energy 1.039708e-03 3.575451e-07 1.039708e-05 displacement 5.444220e-01 8.665884e-03 6.782149e-06 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 9 step from line search = 0.241261 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 3.869041e-09 0.000000e+00 energy 1.039708e-03 9.065717e-08 1.039708e-05 displacement 5.444220e-01 1.788838e-04 6.775326e-06 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 5.036983e-10 0.000000e+00 energy 1.039708e-03 3.767793e-08 1.039708e-05 displacement 5.444220e-01 4.324253e-03 6.958118e-06 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 9.014506e-11 0.000000e+00 energy 1.039708e-03 2.427647e-08 1.039708e-05 displacement 5.444220e-01 3.744728e-04 6.989045e-06 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 3.905043e-10 0.000000e+00 energy 1.039708e-03 2.928465e-08 1.039708e-05 displacement 5.444220e-01 1.077762e-03 7.042190e-06 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 9.083048e-13 0.000000e+00 energy 1.039708e-03 5.607379e-10 1.039708e-05 displacement 5.444220e-01 5.719985e-04 7.007378e-06 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 1 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.244856e-05 1.150644e-18 0.000000e+00 energy 1.039708e-03 1.734022e-13 1.039708e-05 displacement 5.444220e-01 7.704601e-07 7.009800e-06 ------- converged at time : 1 ]0;(step 1/2: 100%) tempModel.feb - FEBio 2.9.0.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 .................... : 22 Total number of equilibrium iterations ............ : 379 Average number of equilibrium iterations .......... : 17.2273 Total number of right hand evaluations ............ : 672 Total number of stiffness reformations ............ : 382 Time in linear solver: 0:01:50 ===== beginning time step 1 : 11 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 3.271962e-05 0.000000e+00 energy 1.109785e-03 1.026928e-03 1.109785e-05 displacement 8.671295e+00 8.671295e+00 8.671295e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 1.104895e-07 0.000000e+00 energy 1.109785e-03 2.910246e-05 1.109785e-05 displacement 8.671295e+00 3.181229e-01 1.199243e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 5.793442e-08 0.000000e+00 energy 1.109785e-03 6.287728e-06 1.109785e-05 displacement 8.671295e+00 3.551477e-01 1.601267e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 2.874865e-07 0.000000e+00 energy 1.109785e-03 2.608177e-05 1.109785e-05 displacement 8.671295e+00 7.757134e-01 2.275066e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 5 step from line search = 0.287403 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 3.105462e-07 0.000000e+00 energy 1.109785e-03 2.140497e-06 1.109785e-05 displacement 8.671295e+00 4.050158e-02 2.403046e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 5.610583e-08 0.000000e+00 energy 1.109785e-03 5.530662e-06 1.109785e-05 displacement 8.671295e+00 4.467448e-01 2.969639e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 7 step from line search = 0.465889 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 1.486368e-07 0.000000e+00 energy 1.109785e-03 8.960063e-07 1.109785e-05 displacement 8.671295e+00 9.608631e-02 3.251078e-05 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 8 step from line search = 0.513468 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 5.591300e-08 0.000000e+00 energy 1.109785e-03 5.319946e-06 1.109785e-05 displacement 8.671295e+00 6.427775e-02 3.467692e-05 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 9 step from line search = 0.391773 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 3.562855e-08 0.000000e+00 energy 1.109785e-03 1.491189e-07 1.109785e-05 displacement 8.671295e+00 3.611511e-02 3.630085e-05 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 2.554335e-08 0.000000e+00 energy 1.109785e-03 3.676163e-07 1.109785e-05 displacement 8.671295e+00 3.099761e-01 4.277481e-05 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 7.338096e-09 0.000000e+00 energy 1.109785e-03 2.451580e-07 1.109785e-05 displacement 8.671295e+00 2.679149e-02 4.159382e-05 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 23 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 1.888428e-10 0.000000e+00 energy 1.109785e-03 9.040037e-08 1.109785e-05 displacement 8.671295e+00 3.227124e-03 4.217922e-05 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 24 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 1.839610e-10 0.000000e+00 energy 1.109785e-03 2.656427e-08 1.109785e-05 displacement 8.671295e+00 1.538747e-03 4.257558e-05 Reforming stiffness matrix: reformation #14 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 14 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 25 stiffness matrix reformations = 14 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 7.429311e-11 0.000000e+00 energy 1.109785e-03 1.696406e-11 1.109785e-05 displacement 8.671295e+00 1.439820e-04 4.244220e-05 Reforming stiffness matrix: reformation #15 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 15 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 26 stiffness matrix reformations = 15 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 8.176565e-16 0.000000e+00 energy 1.109785e-03 1.159284e-11 1.109785e-05 displacement 8.671295e+00 6.874093e-05 4.253913e-05 Reforming stiffness matrix: reformation #16 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 16 Nonlinear solution status: time= 11 stiffness updates = 0 right hand side evaluations = 27 stiffness matrix reformations = 16 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.251709e-05 2.295743e-23 0.000000e+00 energy 1.109785e-03 2.285780e-17 1.109785e-05 displacement 8.671295e+00 3.948931e-09 4.253984e-05 ------- converged at time : 11 ]0;(step 2/2: 10%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: decreasing time step, dt = 9.68563 ===== beginning time step 2 : 20.6856 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 3.105730e-05 0.000000e+00 energy 1.104541e-03 1.002619e-03 1.104541e-05 displacement 5.449006e+00 5.449006e+00 5.449006e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 7.365584e-08 0.000000e+00 energy 1.104541e-03 1.387815e-05 1.104541e-05 displacement 5.449006e+00 2.112425e-01 4.053932e-06 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 7.136295e-08 0.000000e+00 energy 1.104541e-03 2.048296e-06 1.104541e-05 displacement 5.449006e+00 1.491333e-01 2.897194e-06 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 2.449722e-08 0.000000e+00 energy 1.104541e-03 3.027963e-06 1.104541e-05 displacement 5.449006e+00 1.614056e-01 2.023985e-06 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 2.113496e-08 0.000000e+00 energy 1.104541e-03 5.226233e-06 1.104541e-05 displacement 5.449006e+00 2.235712e-01 1.569197e-06 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 7.351243e-09 0.000000e+00 energy 1.104541e-03 2.395905e-06 1.104541e-05 displacement 5.449006e+00 9.621980e-02 1.345965e-06 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 1.748082e-09 0.000000e+00 energy 1.104541e-03 1.288226e-07 1.104541e-05 displacement 5.449006e+00 1.986516e-02 1.394171e-06 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 6.783402e-10 0.000000e+00 energy 1.104541e-03 1.119704e-08 1.104541e-05 displacement 5.449006e+00 5.839661e-04 1.392903e-06 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 2.225168e-12 0.000000e+00 energy 1.104541e-03 2.616460e-10 1.104541e-05 displacement 5.449006e+00 4.207730e-05 1.393855e-06 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 1.438350e-17 0.000000e+00 energy 1.104541e-03 1.481305e-13 1.104541e-05 displacement 5.449006e+00 1.843133e-06 1.394014e-06 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 20.6856 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.298875e-05 4.057360e-27 0.000000e+00 energy 1.104541e-03 1.677859e-21 1.104541e-05 displacement 5.449006e+00 3.195765e-11 1.394015e-06 ------- converged at time : 20.6856 ]0;(step 2/2: 20%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 16.4483 ===== beginning time step 3 : 37.1339 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 3.168946e-05 0.000000e+00 energy 1.060309e-03 9.823691e-04 1.060309e-05 displacement 8.576552e+00 8.576552e+00 8.576552e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 9.549714e-08 0.000000e+00 energy 1.060309e-03 2.498569e-05 1.060309e-05 displacement 8.576552e+00 3.436765e-01 1.206481e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 6.959098e-08 0.000000e+00 energy 1.060309e-03 4.859871e-06 1.060309e-05 displacement 8.576552e+00 3.547435e-01 1.609845e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 4 step from line search = 0.490448 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 1.452547e-07 0.000000e+00 energy 1.060309e-03 3.781443e-06 1.060309e-05 displacement 8.576552e+00 1.322697e-01 1.873344e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 2.842813e-08 0.000000e+00 energy 1.060309e-03 1.462615e-06 1.060309e-05 displacement 8.576552e+00 4.516914e-01 2.434806e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 4.414205e-08 0.000000e+00 energy 1.060309e-03 2.787406e-06 1.060309e-05 displacement 8.576552e+00 9.653614e-02 2.662466e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 7 step from line search = 0.616229 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 1.678289e-08 0.000000e+00 energy 1.060309e-03 1.220917e-06 1.060309e-05 displacement 8.576552e+00 2.322668e-02 2.750989e-05 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 2.592380e-09 0.000000e+00 energy 1.060309e-03 3.725933e-07 1.060309e-05 displacement 8.576552e+00 1.234614e-02 2.775078e-05 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 2.319942e-09 0.000000e+00 energy 1.060309e-03 2.069029e-07 1.060309e-05 displacement 8.576552e+00 8.847887e-03 2.817450e-05 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 1.190268e-09 0.000000e+00 energy 1.060309e-03 2.105126e-07 1.060309e-05 displacement 8.576552e+00 1.165539e-02 2.872852e-05 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 11 step from line search = 0.417930 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 1.063007e-09 0.000000e+00 energy 1.060309e-03 1.198202e-07 1.060309e-05 displacement 8.576552e+00 2.596393e-03 2.848840e-05 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 21 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 9.042232e-11 0.000000e+00 energy 1.060309e-03 4.503254e-09 1.060309e-05 displacement 8.576552e+00 6.163627e-04 2.845312e-05 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 37.1339 stiffness updates = 0 right hand side evaluations = 22 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.138659e-05 2.997545e-15 0.000000e+00 energy 1.060309e-03 4.699128e-11 1.060309e-05 displacement 8.576552e+00 1.292741e-05 2.844658e-05 ------- converged at time : 37.1339 ]0;(step 2/2: 36%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 18.9369 ===== beginning time step 4 : 56.0709 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 3.093874e-05 0.000000e+00 energy 1.084600e-03 9.816356e-04 1.084600e-05 displacement 5.549388e+00 5.549388e+00 5.549388e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 6.142345e-08 0.000000e+00 energy 1.084600e-03 1.208849e-05 1.084600e-05 displacement 5.549388e+00 2.041966e-01 4.155410e-06 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 2.981380e-08 0.000000e+00 energy 1.084600e-03 3.030272e-06 1.084600e-05 displacement 5.549388e+00 7.463332e-02 3.294590e-06 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 5.014931e-08 0.000000e+00 energy 1.084600e-03 3.755073e-07 1.084600e-05 displacement 5.549388e+00 2.247998e-01 2.168961e-06 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 2.276317e-08 0.000000e+00 energy 1.084600e-03 2.630278e-06 1.084600e-05 displacement 5.549388e+00 4.357844e-02 1.874000e-06 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 4.122000e-09 0.000000e+00 energy 1.084600e-03 1.976231e-07 1.084600e-05 displacement 5.549388e+00 6.417487e-03 1.774561e-06 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 8.472790e-10 0.000000e+00 energy 1.084600e-03 3.920211e-09 1.084600e-05 displacement 5.549388e+00 1.248892e-03 1.735790e-06 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 1.967583e-11 0.000000e+00 energy 1.084600e-03 1.566028e-09 1.084600e-05 displacement 5.549388e+00 7.305902e-05 1.734038e-06 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 1.535254e-11 0.000000e+00 energy 1.084600e-03 3.847142e-10 1.084600e-05 displacement 5.549388e+00 2.904715e-06 1.732690e-06 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 1.254491e-17 0.000000e+00 energy 1.084600e-03 4.269489e-13 1.084600e-05 displacement 5.549388e+00 2.050950e-06 1.732059e-06 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 56.0709 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.289987e-05 9.014816e-27 0.000000e+00 energy 1.084600e-03 4.099632e-20 1.084600e-05 displacement 5.549388e+00 1.026010e-11 1.732058e-06 ------- converged at time : 56.0709 ]0;(step 2/2: 55%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 24.1477 ===== beginning time step 5 : 80.2185 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 3.142960e-05 0.000000e+00 energy 1.042223e-03 9.634750e-04 1.042223e-05 displacement 8.510914e+00 8.510914e+00 8.510914e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 9.356427e-08 0.000000e+00 energy 1.042223e-03 2.372212e-05 1.042223e-05 displacement 8.510914e+00 3.360515e-01 1.194319e-05 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 4.630230e-08 0.000000e+00 energy 1.042223e-03 4.147456e-06 1.042223e-05 displacement 8.510914e+00 2.720624e-01 1.538821e-05 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 1.009728e-07 0.000000e+00 energy 1.042223e-03 6.631895e-06 1.042223e-05 displacement 8.510914e+00 6.104351e-01 2.142799e-05 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 1.367056e-08 0.000000e+00 energy 1.042223e-03 1.800204e-06 1.042223e-05 displacement 8.510914e+00 9.174397e-02 2.358765e-05 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 12 stiffness matrix reformations = 6 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 1.967967e-08 0.000000e+00 energy 1.042223e-03 3.569082e-07 1.042223e-05 displacement 8.510914e+00 1.161039e-01 2.634486e-05 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 4.547124e-09 0.000000e+00 energy 1.042223e-03 1.599107e-07 1.042223e-05 displacement 8.510914e+00 9.519997e-03 2.672400e-05 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 5.395167e-09 0.000000e+00 energy 1.042223e-03 6.598867e-07 1.042223e-05 displacement 8.510914e+00 5.901318e-03 2.688972e-05 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 9 step from line search = 0.606773 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 2.523812e-09 0.000000e+00 energy 1.042223e-03 1.216873e-07 1.042223e-05 displacement 8.510914e+00 2.057095e-03 2.701840e-05 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 9.580213e-10 0.000000e+00 energy 1.042223e-03 5.468581e-09 1.042223e-05 displacement 8.510914e+00 3.598245e-03 2.741863e-05 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 1.408194e-10 0.000000e+00 energy 1.042223e-03 7.411342e-08 1.042223e-05 displacement 8.510914e+00 9.268648e-04 2.751217e-05 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 6.671840e-14 0.000000e+00 energy 1.042223e-03 4.952851e-10 1.042223e-05 displacement 8.510914e+00 1.078787e-04 2.756771e-05 Reforming stiffness matrix: reformation #13 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 13 Nonlinear solution status: time= 80.2185 stiffness updates = 0 right hand side evaluations = 20 stiffness matrix reformations = 13 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.116229e-05 3.408373e-22 0.000000e+00 energy 1.042223e-03 2.142193e-16 1.042223e-05 displacement 8.510914e+00 8.103976e-09 2.756794e-05 ------- converged at time : 80.2185 ]0;(step 2/2: 79%) tempModel.feb - FEBio 2.9.0.0 AUTO STEPPER: increasing time step, dt = 26.0652 MUST POINT CONTROLLER: adjusting time step. dt = 20.7815 ===== beginning time step 6 : 101 ===== Reforming stiffness matrix: reformation #1 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 1 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 7 stiffness matrix reformations = 1 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 3.088765e-05 0.000000e+00 energy 1.069682e-03 9.691314e-04 1.069682e-05 displacement 5.446248e+00 5.446248e+00 5.446248e-06 Reforming stiffness matrix: reformation #2 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 2 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 8 stiffness matrix reformations = 2 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 5.305079e-08 0.000000e+00 energy 1.069682e-03 1.224090e-05 1.069682e-05 displacement 5.446248e+00 2.215345e-01 3.979359e-06 Reforming stiffness matrix: reformation #3 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 3 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 9 stiffness matrix reformations = 3 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 1.250748e-08 0.000000e+00 energy 1.069682e-03 1.434179e-06 1.069682e-05 displacement 5.446248e+00 5.811574e-02 3.246820e-06 Reforming stiffness matrix: reformation #4 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 4 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 10 stiffness matrix reformations = 4 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 3.519911e-08 0.000000e+00 energy 1.069682e-03 9.009204e-07 1.069682e-05 displacement 5.446248e+00 1.467185e-01 2.330657e-06 Reforming stiffness matrix: reformation #5 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 5 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 11 stiffness matrix reformations = 5 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 6.806572e-09 0.000000e+00 energy 1.069682e-03 2.845513e-07 1.069682e-05 displacement 5.446248e+00 1.153065e-02 2.182504e-06 Reforming stiffness matrix: reformation #6 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 6 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 13 stiffness matrix reformations = 6 step from line search = 0.596973 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 4.560337e-09 0.000000e+00 energy 1.069682e-03 3.191068e-07 1.069682e-05 displacement 5.446248e+00 8.987804e-04 2.177012e-06 Reforming stiffness matrix: reformation #7 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 7 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 14 stiffness matrix reformations = 7 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 7.740303e-10 0.000000e+00 energy 1.069682e-03 7.725314e-08 1.069682e-05 displacement 5.446248e+00 3.895888e-03 2.060085e-06 Reforming stiffness matrix: reformation #8 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 8 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 15 stiffness matrix reformations = 8 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 3.835079e-10 0.000000e+00 energy 1.069682e-03 3.821540e-09 1.069682e-05 displacement 5.446248e+00 2.731147e-04 2.036159e-06 Reforming stiffness matrix: reformation #9 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 9 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 16 stiffness matrix reformations = 9 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 2.989146e-10 0.000000e+00 energy 1.069682e-03 1.127468e-10 1.069682e-05 displacement 5.446248e+00 3.113230e-05 2.032831e-06 Reforming stiffness matrix: reformation #10 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 10 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 17 stiffness matrix reformations = 10 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 3.093933e-10 0.000000e+00 energy 1.069682e-03 5.701079e-10 1.069682e-05 displacement 5.446248e+00 4.258930e-05 2.026853e-06 Reforming stiffness matrix: reformation #11 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 11 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 18 stiffness matrix reformations = 11 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 3.299223e-13 0.000000e+00 energy 1.069682e-03 8.471907e-11 1.069682e-05 displacement 5.446248e+00 3.371042e-05 2.021394e-06 Reforming stiffness matrix: reformation #12 ===== reforming stiffness matrix: Nr of equations ........................... : 11784 Nr of nonzeroes in stiffness matrix ....... : 906480 12 Nonlinear solution status: time= 101 stiffness updates = 0 right hand side evaluations = 19 stiffness matrix reformations = 12 step from line search = 1.000000 convergence norms : INITIAL CURRENT REQUIRED residual 3.278007e-05 2.023433e-13 0.000000e+00 energy 1.069682e-03 1.079189e-11 1.069682e-05 displacement 5.446248e+00 1.111166e-07 2.021184e-06 ------- converged at time : 101 ]0;(step 2/2: 100%) tempModel.feb - FEBio 2.9.0.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 .................... : 6 Total number of equilibrium iterations ............ : 76 Average number of equilibrium iterations .......... : 12.6667 Total number of right hand evaluations ............ : 122 Total number of stiffness reformations ............ : 76 Time in linear solver: 0:02:10 Elapsed time : 0:04:23 N O R M A L T E R M I N A T I O N Waiting for log file... Proceeding to check log file...04-Jun-2019 13:11:18 ------- converged at time : 0.01 ------- converged at time : 0.038 ------- converged at time : 0.0744984 ------- converged at time : 0.123697 ------- converged at time : 0.174679 ------- converged at time : 0.21587 ------- converged at time : 0.259125 ------- converged at time : 0.309077 ------- converged at time : 0.356006 ------- converged at time : 0.39666 ------- converged at time : 0.437315 ------- converged at time : 0.489839 ------- converged at time : 0.539182 ------- converged at time : 0.597023 ------- converged at time : 0.657991 ------- converged at time : 0.72291 ------- converged at time : 0.777792 ------- converged at time : 0.838 ------- converged at time : 0.89297 ------- converged at time : 0.940639 ------- converged at time : 0.984164 ------- converged at time : 1 ------- converged at time : 11 ------- converged at time : 20.6856 ------- converged at time : 37.1339 ------- converged at time : 56.0709 ------- converged at time : 80.2185 ------- converged at time : 101 --- Done --- 04-Jun-2019 13:11:18

Import FEBio results
if 1%runFlag==1 %i.e. a succesful run
% Importing nodal displacements from a log file [time_mat, N_disp_mat,~]=importFEBio_logfile(fullfile(savePath,febioLogFileName_disp)); %Nodal displacements time_mat=[0; time_mat(:)]; %Time N_disp_mat=N_disp_mat(:,2:end,:); sizImport=size(N_disp_mat); sizImport(3)=sizImport(3)+1; N_disp_mat_n=zeros(sizImport); N_disp_mat_n(:,:,2:end)=N_disp_mat; N_disp_mat=N_disp_mat_n; DN=N_disp_mat(:,:,end); DN_magnitude=sqrt(sum(DN.^2,2)); V_def=V+DN; V_DEF=N_disp_mat+repmat(V,[1 1 size(N_disp_mat,3)]); X_DEF=V_DEF(:,1,:); Y_DEF=V_DEF(:,2,:); Z_DEF=V_DEF(:,3,:); % [CF]=vertexToFaceMeasure(Fb_all,DN_magnitude);
Importing element strain energies from a log file
[~,E_energy,~]=importFEBio_logfile(fullfile(savePath,febioLogFileName_strainEnergy)); %Element stresses %Remove nodal index column E_energy=E_energy(:,2:end,:); %Add initial state i.e. zero displacement sizImport=size(E_energy); sizImport(3)=sizImport(3)+1; E_energy_mat_n=zeros(sizImport); E_energy_mat_n(:,:,2:end)=E_energy; E_energy=E_energy_mat_n;
indBlob=unique(Fb_blob(:));
t=linspace(0,2*pi,250)';
V_def_blob=V(indBlob,:)+N_disp_mat(indBlob,:,end);
[~,indMin]=min(V_def_blob(:,1));
[~,indMax]=max(V_def_blob(:,1));
xEnd=V_def_blob(indMin,1);
xStart=V_def_blob(indMax,1);
rEnd=sphereRadius+(xEnd.*((sphereRadius-tubeRadius(2))/tubeLength));
rStart=sphereRadius+(xStart.*((sphereRadius-tubeRadius(2))/tubeLength));
xMid=mean([xStart xEnd]);%sum([rStart rEnd].*[xStart xEnd])./sum([rStart rEnd]);
rMid=sphereRadius+(xMid.*((sphereRadius-tubeRadius(2))/tubeLength));
V_plot_xEnd=[xEnd*ones(size(t)) rEnd*cos(t) rEnd*sin(t)];
V_plot_xMid=[xMid*ones(size(t)) rMid*cos(t) rMid*sin(t)];
V_plot_xStart=[xStart*ones(size(t)) rStart*cos(t) rStart*sin(t)];
Plotting the simulated results using anim8 to visualize and animate deformations
% Create basic view and store graphics handle to initiate animation hf=cFigure; hold on; ht=gtitle(['Radial stretch: ',num2str(rMid/sphereRadius)]); hp1=gpatch(Fb_blob,V_def,DN_magnitude,'none',1); %Add graphics object to animate hp2=plotV(V_plot_xEnd ,'r-','LineWidth',3); hp3=plotV(V_plot_xMid ,'r-','LineWidth',3); hp4=plotV(V_plot_xStart,'r-','LineWidth',3); gpatch(F_tube,V_def,'kw','none',0.25); %Add graphics object to animate axisGeom(gca,fontSize); colormap(cMap); colorbar; caxis([0 max(DN_magnitude(:))]); caxis manual; axis([min(X_DEF(:)) max(X_DEF(:)) min(Y_DEF(:)) max(Y_DEF(:)) min(Z_DEF(:)) max(Z_DEF(:))]); camlight headlight; lighting gouraud; view(0,0); % view(-30,30); zoom(1.5); axis off; drawnow; % Set up animation features animStruct.Time=time_mat; %The time vector for qt=1:1:size(N_disp_mat,3) %Loop over time increments DN=N_disp_mat(:,:,qt); %Current displacement DN_magnitude=sqrt(sum(DN.^2,2)); V_def=V+DN; %Current nodal coordinates V_def_blob=V_def(indBlob,:); [~,indMin]=min(V_def_blob(:,1)); [~,indMax]=max(V_def_blob(:,1)); xEnd=V_def_blob(indMin,1); xStart=V_def_blob(indMax,1); rEnd=sphereRadius+(xEnd.*((sphereRadius-tubeRadius(2))/tubeLength)); rStart=sphereRadius+(xStart.*((sphereRadius-tubeRadius(2))/tubeLength)); xMid=mean([xStart xEnd]);%sum([rStart rEnd].*[xStart xEnd])./sum([rStart rEnd]); rMid=sphereRadius+(xMid.*((sphereRadius-tubeRadius(2))/tubeLength)); V_plot_xEnd=[xEnd*ones(size(t)) rEnd*cos(t) rEnd*sin(t)]; V_plot_xMid=[xMid*ones(size(t)) rMid*cos(t) rMid*sin(t)]; V_plot_xStart=[xStart*ones(size(t)) rStart*cos(t) rStart*sin(t)]; %Set entries in animation structure animStruct.Handles{qt}=[hp1 hp1 hp2 hp2 hp2 hp3 hp3 hp3 hp4 hp4 hp4 ht]; %Handles of objects to animate animStruct.Props{qt}={'Vertices','CData','XData','YData','ZData','XData','YData','ZData','XData','YData','ZData','String'}; %Properties of objects to animate animStruct.Set{qt}={V_def,DN_magnitude,... V_plot_xEnd(:,1),V_plot_xEnd(:,2),V_plot_xEnd(:,3),... V_plot_xMid(:,1),V_plot_xMid(:,2),V_plot_xMid(:,3),... V_plot_xStart(:,1),V_plot_xStart(:,2),V_plot_xStart(:,3),... ['Radial stretch: ',num2str(rMid/sphereRadius)]}; %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/master/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) 2019 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/.